diff --git a/CHANGES b/CHANGES
index 615f074ae..75b5b1789 100644
--- a/CHANGES
+++ b/CHANGES
@@ -1,3 +1,9 @@
+ * Major changes
+
+ -- the initial model generators have been removed from MAESTRO/
+ and are now a standalone git repo in the amrex-astro github
+ organization
+
18.07
* Major changes
diff --git a/Util/initial_models/GInitModels.mak b/Util/initial_models/GInitModels.mak
deleted file mode 100644
index e9433eedc..000000000
--- a/Util/initial_models/GInitModels.mak
+++ /dev/null
@@ -1,171 +0,0 @@
-# A set of useful macros for putting together one of the initial model
-# generator routines
-
-# include the main Makefile stuff
-include $(FBOXLIB_HOME)/Tools/F_mk/GMakedefs.mak
-
-# default target (make just takes the one that appears first)
-ALL: init_1d.$(suf).exe
-
-
-#-----------------------------------------------------------------------------
-# core FBoxLib directories
-FBOXLIB_CORE := Src/BaseLib
-FPP_DEFINES += -DAMREX_DEVICE=""
-
-
-#-----------------------------------------------------------------------------
-# MAESTRO directories needed
-Fmdirs := Microphysics/EOS
-
-# the helmeos has an include file -- also add a target to link the table
-# into the problem directory.
-ifeq ($(findstring helmeos, $(EOS_DIR)), helmeos)
- EOS_DIR := helmholtz
- EOS_TOP_DIR := $(MICROPHYSICS_HOME)/EOS
- EOS_PATH := $(EOS_TOP_DIR)/helmholtz
- ALL: table
-endif
-
-table:
- @if [ ! -f helm_table.dat ]; then echo ${bold}Linking helm_table.dat${normal}; ln -s $(EOS_PATH)/helm_table.dat .; fi
-
-ifeq ($(findstring multigamma, $(EOS_DIR)), multigamma)
- EOS_TOP_DIR := $(MICROPHYSICS_HOME)/EOS
-endif
-
-MICROPHYS_CORE := $(MAESTRO_TOP_DIR)/Microphysics/EOS $(MAESTRO_TOP_DIR)/Microphysics/screening
-
-# locations of the microphysics
-ifndef EOS_TOP_DIR
- EOS_TOP_DIR := $(MAESTRO_TOP_DIR)/Microphysics/EOS
-endif
-
-ifndef NETWORK_TOP_DIR
- NETWORK_TOP_DIR := $(MAESTRO_TOP_DIR)/Microphysics/networks
-endif
-
-ifndef CONDUCTIVITY_TOP_DIR
- CONDUCTIVITY_TOP_DIR := $(MAESTRO_TOP_DIR)/Microphysics/conductivity
-endif
-
-ifndef CONDUCTIVITY_DIR
- CONDUCTIVITY_DIR = constant
-endif
-
-# add in the network, EOS, and conductivity
-MICROPHYS_CORE += $(EOS_TOP_DIR)/$(EOS_DIR) \
- $(NETWORK_TOP_DIR)/$(NETWORK_DIR) \
- $(NETWORK_TOP_DIR) \
- $(CONDUCTIVITY_TOP_DIR)/$(CONDUCTIVITY_DIR)
-
-# get any additional network dependencies
-include $(NETWORK_TOP_DIR)/$(strip $(NETWORK_DIR))/NETWORK_REQUIRES
-
-ifdef NEED_VODE
- Fmdirs += Util/VODE Util/LINPACK Util/BLAS
-endif
-
-ifdef NEED_BLAS
- Fmdirs += Util/BLAS
-endif
-
-ifdef NEED_LINPACK
- UTIL_CORE += Util/LINPACK
-endif
-
-ifdef NEED_VBDF
- UTIL_CORE += Util/VBDF
-endif
-
-Fmdirs += Util/model_parser Util/simple_log
-
-
-# explicitly add in any source defined in the build directory
-f90sources += $(MODEL_SOURCES)
-
-
-#-----------------------------------------------------------------------------
-# core FBoxLib directories
-Fmpack := $(foreach dir, $(FBOXLIB_CORE), $(FBOXLIB_HOME)/$(dir)/GPackage.mak)
-Fmlocs := $(foreach dir, $(FBOXLIB_CORE), $(FBOXLIB_HOME)/$(dir))
-Fmincs :=
-
-# auxillary directories
-Fmpack += $(foreach dir, $(Fmdirs), $(MAESTRO_TOP_DIR)/$(dir)/GPackage.mak)
-Fmpack += $(foreach dir, $(MICROPHYS_CORE), $(dir)/GPackage.mak)
-
-Fmlocs += $(foreach dir, $(Fmdirs), $(MAESTRO_TOP_DIR)/$(dir))
-Fmlocs += $(foreach dir, $(MICROPHYS_CORE), $(dir))
-
-Fmincs += $(foreach dir, $(Fmincludes), $(MAESTRO_TOP_DIR)/$(dir))
-
-
-# include the necessary GPackage.mak files that define this setup
-include $(Fmpack)
-
-
-
-# we need a probin.f90, since the various microphysics routines can
-# have runtime parameters
-f90sources += probin.f90
-
-PROBIN_TEMPLATE := $(MAESTRO_TOP_DIR)/Util/parameters/dummy.probin.template
-PROBIN_PARAMETER_DIRS = $(MAESTRO_TOP_DIR)/Util/initial_models/
-EXTERN_PARAMETER_DIRS += $(MICROPHYS_CORE) $(NETWORK_TOP_DIR)
-
-
-PROBIN_PARAMETERS := $(shell $(FBOXLIB_HOME)/Tools/F_scripts/findparams.py $(PROBIN_PARAMETER_DIRS))
-EXTERN_PARAMETERS := $(shell $(FBOXLIB_HOME)/Tools/F_scripts/findparams.py $(EXTERN_PARAMETER_DIRS))
-
-probin.f90: $(PROBIN_PARAMETERS) $(EXTERN_PARAMETERS) $(PROBIN_TEMPLATE)
- @echo " "
- @echo "${bold}WRITING probin.f90${normal}"
- $(FBOXLIB_HOME)/Tools/F_scripts/write_probin.py \
- -t $(PROBIN_TEMPLATE) -o probin.f90 -n probin \
- --pa "$(PROBIN_PARAMETERS)" --pb "$(EXTERN_PARAMETERS)"
- @echo " "
-
-
-
-
-
-# vpath defines the directories to search for the source files
-
-# VPATH_LOCATIONS to first search in the problem directory
-# Note: GMakerules.mak will include '.' at the start of the
-VPATH_LOCATIONS += $(Fmlocs)
-
-
-# we need the MAESTRO constants
-f90sources += constants_cgs.f90
-VPATH_LOCATIONS += $(MAESTRO_TOP_DIR)/Source
-
-
-# list of directories to put in the Fortran include path
-FINCLUDE_LOCATIONS += $(Fmincs)
-
-
-init_1d.$(suf).exe: $(objects)
- $(LINK.f90) -o init_1d.$(suf).exe $(objects) $(libraries)
- @echo SUCCESS
-
-
-# include the fParallel Makefile rules
-include $(FBOXLIB_HOME)/Tools/F_mk/GMakerules.mak
-
-
-#-----------------------------------------------------------------------------
-# for debugging. To see the value of a Makefile variable,
-# e.g. Fmlocs, simply do "make print-Fmlocs". This will
-# print out the value.
-print-%: ; @echo $* is $($*)
-
-
-#-----------------------------------------------------------------------------
-# cleaning. Add more actions to 'clean' and 'realclean' to remove
-# probin.f90 and build_info.f90 -- this is where the '::' in make comes
-# in handy
-clean::
- $(RM) probin.f90
- $(RM) build_info.f90
diff --git a/Util/initial_models/README b/Util/initial_models/README
deleted file mode 100644
index 4bcd05051..000000000
--- a/Util/initial_models/README
+++ /dev/null
@@ -1,41 +0,0 @@
--- spherical
-
- generate an isentropic, self-gravitating WD model given a core
- temperature and density.
-
-
--- test2
-
- generate an isentropic plane-parallel atmosphere with an entropy
- jump below to surpress convective overshoot. This is used by
- the test2 and test_convect problems.
-
-
--- toy_atm
-
- similar to he_burn. An isentropic layer is placed on top of an
- isothermal base. A jump in temperature at the base of the
- isentropic layer is specified, with a linear transition between the
- base and isentropic layer. The isentropic layer is continued down
- until reaching a cutoff temperature, at which point the model is
- isothermal.
-
-
--- lagrangian_planar
-
- This takes an existing initial model that is unequally gridded
- (in space) and maps it onto a uniform grid and puts it in HSE
- using our equation of state. At the moment, it assumes a
- constant gravitational acceleration and plane-parallel. The
- integration is down (up and down) from the location of the
- peak T in the model, and the temperature profile of the initial
- model is preserved.
-
-
--- kepler_hybrid
-
- These were used for our original set of wdconvect calculations.
- They take a 1-d model from the Kepler stellar evolution code (which
- may not be uniformly spaced), and put it into HSE on the MAESTRO
- grid. This particular version forces the inner region of the star
- to be completely isentropic.
diff --git a/Util/initial_models/_parameters b/Util/initial_models/_parameters
deleted file mode 100644
index e69de29bb..000000000
diff --git a/Util/initial_models/kepler_hybrid/GNUmakefile b/Util/initial_models/kepler_hybrid/GNUmakefile
deleted file mode 100644
index a69112a7e..000000000
--- a/Util/initial_models/kepler_hybrid/GNUmakefile
+++ /dev/null
@@ -1,30 +0,0 @@
-# Makefile for the init_1d initial model generator
-
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../..
-
-
-# EOS and network
-EOS_DIR := helmeos
-
-NETWORK_DIR := general_null
-GENERAL_NET_INPUTS := $(MAESTRO_TOP_DIR)/Microphysics/networks/$(NETWORK_DIR)/ignition_wdconvect.net
-
-
-# the local sources needed to build the initial model generator
-# MODEL_SOURCES := init_1d.f90
-MODEL_SOURCES := init_1d_irreg.f90
-
-
-include ../GInitModels.mak
-
-
diff --git a/Util/initial_models/kepler_hybrid/init_1d.f90 b/Util/initial_models/kepler_hybrid/init_1d.f90
deleted file mode 100644
index 70cace525..000000000
--- a/Util/initial_models/kepler_hybrid/init_1d.f90
+++ /dev/null
@@ -1,1340 +0,0 @@
-!! Take an initial model from a Lagrangian code and put it onto
-!! a uniform grid and make sure that it is happy with the EOS in
-!! our code. The output is a .hse file that can be read directly
-!! by Maestro.
-!!
-!! The model is placed into HSE by the following differencing:
-!!
-!! (1/dr) [
_i -
_{i-1} ] = (1/2) [ _i + _{i-1} ] g
-!!
-!!
-!! We take the temperature structure directly from the original
-!! initial model. We adjust the density and pressure according to
-!! HSE using the EOS.
-!!
-!!***
-
-program init_1d
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use eos_module, only: eos, eos_init
- use eos_type_module, only : eos_t, eos_input_rt
- use network
- use fundamental_constants_module
- use extern_probin_module, only: use_eos_coulomb
-
- implicit none
-
- integer :: i, j, n
-
- real (kind=dp_t), allocatable :: xzn_hse(:), xznl(:), xznr(:)
- real (kind=dp_t), allocatable :: M_enclosed(:)
- real (kind=dp_t), allocatable :: model_kepler_hse(:,:)
- real (kind=dp_t), allocatable :: model_isentropic_hse(:,:)
- real (kind=dp_t), allocatable :: model_hybrid_hse(:,:)
- real (kind=dp_t), allocatable :: entropy_want(:)
-
- integer, parameter :: nx = 1280
-
- ! define convenient indices for the scalars
- integer, parameter :: nvar = 5 + nspec
- integer, parameter :: idens = 1, &
- itemp = 2, &
- ipres = 3, &
- ientr = 4, &
- isndspd = 5, &
- ispec = 6
-
- real (kind=dp_t), save :: xmin, xmax, delx
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone, entropy
-
- real (kind=dp_t) :: A, B, dAdT, dAdrho, dBdT, dBdrho
- real (kind=dp_t) :: dpd, dpt, dsd, dst
-
- real (kind=dp_t) :: central_density
-
- real (kind=dp_t) :: p_want, drho, dtemp
-
- real (kind=dp_t) :: g_zone
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- real (kind=dp_t), parameter :: TOL = 1.e-10
-
- integer, parameter :: MAX_ITER = 250
-
- integer :: iter, iter_dens
-
- integer :: igood
- real (kind=dp_t) :: slope
-
- logical :: converged_hse, converged_central_density, fluff, isentropic
-
- real (kind=dp_t) :: max_temp
-
- integer :: index_hse_fluff
-
- real (kind=dp_t), dimension(nspec) :: xn
-
- real (kind=dp_t), save :: low_density_cutoff, temp_fluff, temp_fluff_cutoff, smallx
-
- integer, parameter :: MAX_VARNAME_LENGTH=80
- integer :: npts_model, nvars_model_file
-
- real(kind=dp_t), allocatable :: base_state(:,:), base_r(:)
- real(kind=dp_t), allocatable :: vars_stored(:)
- character(len=MAX_VARNAME_LENGTH), allocatable :: varnames_stored(:)
- logical :: found
-
- integer :: ipos
- character (len=256) :: header_line, model_file, outfile
- character (len=8) num
-
- real(kind=dp_t) :: interpolate
- real(kind=dp_t) :: sum
-
- integer :: ibegin
- integer :: i_isentropic
-
- real(kind=dp_t), parameter :: M_solar = 1.98892d33
- real(kind=dp_t) :: anelastic_cutoff = 3.e6 ! this is for diagnostics only -- not used in the HSEing
- real(kind=dp_t) :: M_enclosed_anel
- real(kind=dp_t) :: grav_ener, M_center
- real(kind=dp_t) :: eint_hybrid
-
- type (eos_t) :: eos_state
-
- smallx = 1.d-10
-
- ! set the parameters
- model_file = "kepler_new_6.25e8.raw"
-
- xmin = 0_dp_t
- xmax = 5.d8
-
- low_density_cutoff =1.d-4
-
- ! temp_fluff_cutoff is the density below which we hold the temperature
- ! constant for the kepler model
-
- ! MAESTRO
- ! temp_fluff_cutoff = 1.d-4
-
- ! CASTRO
- temp_fluff_cutoff = 1.d3
-
- temp_fluff = 5.d6
-
- ! this comes in via extern_probin_module -- override the default
- ! here if we want
- use_eos_coulomb = .true.
-
-
- ! initialize the EOS and network
- call eos_init()
- call network_init()
-
- !===========================================================================
- ! Create a 1-d uniform grid that is identical to the mesh that we are
- ! mapping onto, and then we want to force it into HSE on that mesh.
- !===========================================================================
-
- ! allocate storage
- allocate(xzn_hse(nx))
- allocate(xznl(nx))
- allocate(xznr(nx))
- allocate(model_kepler_hse(nx,nvar))
- allocate(model_isentropic_hse(nx,nvar))
- allocate(model_hybrid_hse(nx,nvar))
- allocate(M_enclosed(nx))
- allocate(entropy_want(nx))
-
- ! compute the coordinates of the new gridded function
- delx = (xmax - xmin) / dble(nx)
-
- do i = 1, nx
- xznl(i) = xmin + (dble(i) - 1.0_dp_t)*delx
- xznr(i) = xmin + (dble(i))*delx
- xzn_hse(i) = 0.5_dp_t*(xznl(i) + xznr(i))
- enddo
-
-
- !===========================================================================
- ! read in the Kepler model
- !===========================================================================
-
- ! Open the model file and read in the header
- !
- ! the model file is assumed to be of the follow form:
- ! # npts = 178
- ! # num of variables = 6
- ! # density
- ! # temperature
- ! # pressure
- ! # carbon-12
- ! # oxygen-16
- ! # magnesium-24
- ! 195312.5000 5437711139. 8805500.952 .4695704813E+28 0.3 0.7 0
- ! 585937.5000 5410152416. 8816689.836 0.4663923963E+28 0.3 0.7 0
- !
- ! we read in the number of variables and their order and use this to map
- ! them into the base_state array. We ignore anything other than density,
- ! temperature, pressure and composition.
- !
- ! Presently, we take density, temperature, and composition as the
- ! independent variables and use them to define the thermodynamic state.
- !
- ! composition is assumed to be in terms of mass fractions
-
-
- open(99,file=model_file)
-
- ! the first line has the number of points in the model
- read (99, '(a256)') header_line
- ipos = index(header_line, '=') + 1
- read (header_line(ipos:),*) npts_model
-
- print *, npts_model, ' points found in the initial model file'
-
- ! now read in the number of variables
- read (99, '(a256)') header_line
- ipos = index(header_line, '=') + 1
- read (header_line(ipos:),*) nvars_model_file
-
- print *, nvars_model_file, ' variables found in the initial model file'
-
- allocate (vars_stored(nvars_model_file))
- allocate (varnames_stored(nvars_model_file))
-
- ! now read in the names of the variables
- do i = 1, nvars_model_file
- read (99, '(a256)') header_line
- ipos = index(header_line, '#') + 1
- varnames_stored(i) = trim(adjustl(header_line(ipos:)))
- enddo
-
- ! allocate storage for the model data
- allocate (base_state(npts_model, nvar))
- allocate (base_r(npts_model))
-
- do i = 1, npts_model
- read(99,*) base_r(i), (vars_stored(j), j = 1, nvars_model_file)
-
- base_state(i,:) = ZERO
-
- do j = 1, nvars_model_file
-
- found = .false.
-
- select case (trim(varnames_stored(j)))
-
- case ("density")
- base_state(i,idens) = vars_stored(j)
- found = .true.
-
- case ("temperature")
- base_state(i,itemp) = vars_stored(j)
- found = .true.
-
- case ("pressure")
- base_state(i,ipres) = vars_stored(j)
- found = .true.
-
- case default
-
- ! check if they are species
- n = network_species_index(trim(varnames_stored(j)))
- if (n > 0) then
- base_state(i,ispec-1+n) = vars_stored(j)
- found = .true.
- endif
-
- end select
-
- if (.NOT. found) then
- print *, 'ERROR: variable not found: ', varnames_stored(j)
- endif
-
- enddo
-
- enddo
-
-
- open (unit=50, file="model.orig", status="unknown")
-
- write (50,*) "# initial model as read in"
-
- do i = 1, npts_model
- write (50,1000) base_r(i), (base_state(i,j), j = 1, nvar)
- enddo
-
- close (50)
-
-
-
- !===========================================================================
- ! put the model onto our new uniform grid
- !===========================================================================
-
- igood = -1
-
- do i = 1, nx
-
- do n = 1, nvar
-
- if (xzn_hse(i) < base_r(npts_model)) then
-
- model_kepler_hse(i,n) = interpolate(xzn_hse(i), npts_model, &
- base_r, base_state(:,n))
-
- igood = i
- else
-
- !if (n == itemp) then
-
- ! linearly interpolate the last good Kepler zones
- ! slope = (model_kepler_hse(igood,itemp) - model_kepler_hse(igood-1,itemp))/ &
- ! (xzn_hse(igood) - xzn_hse(igood-1))
- !
- ! model_kepler_hse(i,n) = max(temp_fluff, &
- ! model_kepler_hse(igood,itemp) + slope*(xzn_hse(i) - xzn_hse(igood)))
-
- !else
- ! use a zero-gradient at the top of the initial model if our domain is
- ! larger than the model's domain.
-
- model_kepler_hse(i,n) = base_state(npts_model,n)
- !endif
- endif
-
- enddo
-
-
- ! make sure that the species (mass fractions) sum to 1
- sum = 0.0_dp_t
- do n = ispec,ispec-1+nspec
- model_kepler_hse(i,n) = max(model_kepler_hse(i,n),smallx)
- sum = sum + model_kepler_hse(i,n)
- enddo
-
- do n = ispec,ispec-1+nspec
- model_kepler_hse(i,n) = model_kepler_hse(i,n)/sum
- enddo
-
- enddo
-
-
-
- open (unit=30, file="model.uniform", status="unknown")
-
-1000 format (1x, 12(g26.16, 1x))
-
- write (30,*) "# initial model just after putting onto a uniform grid"
-
- do i = 1, nx
-
- write (30,1000) xzn_hse(i), model_kepler_hse(i,idens), model_kepler_hse(i,itemp), &
- model_kepler_hse(i,ipres), (model_kepler_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=30)
-
- !===========================================================================
- ! iterate to find the central density
- !===========================================================================
-
- ! because the Kepler model likely begins at a larger radius than our first
- ! HSE model zone, simple interpolation will not do a good job. We want to
- ! integrate in from the zone that best matches the first Kepler model zone,
- ! assuming HSE and constant entropy.
-
-
- ! find the zone in the uniformly gridded model that corresponds to the
- ! first zone of the original model
- ibegin = -1
- do i = 1, nx
- if (xzn_hse(i) >= base_r(1)) then
- ibegin = i
- exit
- endif
- enddo
-
- print *, 'ibegin = ', ibegin
-
-
- ! store the central density. We will iterate until the central density
- ! converges
- central_density = model_kepler_hse(1,idens)
- print *, 'interpolated central density = ', central_density
-
- do iter_dens = 1, max_iter
-
- ! compute the enclosed mass
- M_enclosed(1) = FOUR3RD*M_PI*delx**3*model_kepler_hse(1,idens)
-
- do i = 2, ibegin
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_kepler_hse(i,idens)
- enddo
-
-
- ! now start at ibegin and integrate inward
- eos_state%T = model_kepler_hse(ibegin,itemp)
- eos_state%rho = model_kepler_hse(ibegin,idens)
- eos_state%xn(:) = model_kepler_hse(ibegin,ispec:nvar)
-
- call eos(eos_input_rt, eos_state)
-
- model_kepler_hse(ibegin,ipres) = eos_state%p
- model_kepler_hse(ibegin,ientr) = eos_state%s
- model_kepler_hse(ibegin,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- entropy_want(:) = eos_state%s
-
-
- do i = ibegin-1, 1, -1
-
-
- ! as the initial guess for the temperature and density, use
- ! the previous zone
- dens_zone = model_kepler_hse(i+1,idens)
- temp_zone = model_kepler_hse(i+1,itemp)
- xn(:) = model_kepler_hse(i,ispec:nvar)
-
- ! compute the gravitational acceleration on the interface between zones
- ! i and i+1
- g_zone = -Gconst*M_enclosed(i)/(xznr(i)*xznr(i))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- do iter = 1, MAX_ITER
-
- p_want = model_kepler_hse(i+1,ipres) - &
- delx*0.5_dp_t*(dens_zone + model_kepler_hse(i+1,idens))*g_zone
-
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_want(i) - entropy
-
- dAdT = -dpt
- dAdrho = -0.5d0*delx*g_zone - dpd
- dBdT = -dst
- dBdrho = -dsd
-
- dtemp = (B - (dBdrho/dAdrho)*A)/ &
- ((dBdrho/dAdrho)*dAdT - dBdT)
-
- drho = -(A + dAdT*dtemp)/dAdrho
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- ! if (A < TOL .and. B < ETOL) then
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- ! update the thermodynamics in this zone
- model_kepler_hse(i,idens) = dens_zone
- model_kepler_hse(i,itemp) = temp_zone
- model_kepler_hse(i,ipres) = pres_zone
- model_kepler_hse(i,ientr) = eos_state%s
- model_kepler_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- enddo
-
- if (abs(model_kepler_hse(1,idens) - central_density) < TOL*central_density) then
- converged_central_density = .true.
- exit
- endif
-
- central_density = model_kepler_hse(1,idens)
-
- enddo
-
- if (.NOT. converged_central_density) then
- print *, 'ERROR: central density iterations did not converge'
- call bl_error('ERROR: non-convergence')
- endif
-
-
- print *, 'converged central density = ', model_kepler_hse(1,idens)
- print *, ' '
-
- !===========================================================================
- ! compute the full HSE model using our new central density and temperature,
- ! and the temperature structure as dictated by the Kepler model.
- !===========================================================================
-
- print *, 'putting Kepler model into HSE on our grid...'
-
- ! compute the enclosed mass
- M_enclosed(1) = FOUR3RD*M_PI*delx**3*model_kepler_hse(1,idens)
-
- fluff = .FALSE.
-
- do i = 2, nx
-
- ! use previous zone as initial guess for T, rho
- dens_zone = model_kepler_hse(i-1,idens)
- temp_zone = model_kepler_hse(i-1,itemp)
-
- xn(:) = model_kepler_hse(i,ispec:nvar)
-
- ! compute the gravitational acceleration on the interface between zones
- ! i-1 and i
- g_zone = -Gconst*M_enclosed(i-1)/(xznr(i-1)*xznr(i-1))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- do iter = 1, MAX_ITER
-
-
- ! HSE differencing
- p_want = model_kepler_hse(i-1,ipres) + &
- delx*0.5_dp_t*(dens_zone + model_kepler_hse(i-1,idens))*g_zone
-
- temp_zone = model_kepler_hse(i,itemp)
-
- if (model_kepler_hse(i-1,idens) .lt. temp_fluff_cutoff) then
- temp_zone = temp_fluff
- end if
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
- drho = (p_want - pres_zone)/(dpd - 0.5_dp_t*delx*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- index_hse_fluff = i
- exit
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
-
- ! update the thermodynamics in this zone
- model_kepler_hse(i,idens) = dens_zone
- model_kepler_hse(i,itemp) = temp_zone
- model_kepler_hse(i,ipres) = pres_zone
- model_kepler_hse(i,ientr) = eos_state%s
- model_kepler_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_kepler_hse(i,idens)
-
- enddo
-
-
- !===========================================================================
- ! compute the alternate model using the same central density and
- ! temperature, but assuming that we are isentropic (and in HSE).
- !===========================================================================
-
- print *, 'creating isentropic model...'
-
- ! as an initial guess, use the Kepler HSE model
- model_isentropic_hse(:,:) = model_kepler_hse(:,:)
-
- entropy_want(:) = model_isentropic_hse(1,ientr)
-
- fluff = .false.
- isentropic = .true.
-
- ! keep track of the mass enclosed below the current zone
- M_enclosed(1) = FOUR3RD*M_PI*delx**3*model_isentropic_hse(1,idens)
-
- do i = 2, nx
-
- ! use previous zone as initial guess for T, rho
- dens_zone = model_isentropic_hse(i-1,idens)
- temp_zone = model_isentropic_hse(i-1,itemp)
-
- xn(:) = model_isentropic_hse(i,ispec:nvar)
-
- g_zone = -Gconst*M_enclosed(i-1)/(xznr(i-1)*xznr(i-1))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- do iter = 1, MAX_ITER
-
- if (isentropic) then
-
- p_want = model_isentropic_hse(i-1,ipres) + &
- delx*0.5_dp_t*(dens_zone + model_isentropic_hse(i-1,idens))*g_zone
-
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_want(i) - entropy
-
- dAdT = -dpt
- dAdrho = 0.5d0*delx*g_zone - dpd
- dBdT = -dst
- dBdrho = -dsd
-
- dtemp = (B - (dBdrho/dAdrho)*A)/ &
- ((dBdrho/dAdrho)*dAdT - dBdT)
-
- drho = -(A + dAdT*dtemp)/dAdrho
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- ! if (A < TOL .and. B < ETOL) then
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- else
-
- ! do isothermal
- p_want = model_isentropic_hse(i-1,ipres) + &
- delx*0.5*(dens_zone + model_isentropic_hse(i-1,idens))*g_zone
-
- temp_zone = temp_fluff
-
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- isentropic = .false.
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- ! update the thermodynamics in this zone
- model_isentropic_hse(i,idens) = dens_zone
- model_isentropic_hse(i,itemp) = temp_zone
- model_isentropic_hse(i,ipres) = pres_zone
- model_isentropic_hse(i,ientr) = eos_state%s
- model_isentropic_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i))* &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_isentropic_hse(i,idens)
-
- enddo
-
-
- !===========================================================================
- ! compute a hybrid model -- isentropic in the interior, Kepler's temperature
- ! structure outside.
- !===========================================================================
-
- print *, 'creating hybrid model...'
- print *, ' '
- eint_hybrid = 0.0
-
-
- max_temp = maxval(model_kepler_hse(:,itemp))
- i_isentropic = -1
- do i = 1, nx
- model_hybrid_hse(i,:) = model_isentropic_hse(i,:)
-
- if (model_kepler_hse(i,itemp) > model_isentropic_hse(i,itemp)) then
-
- ! there will be a few regions in the very, very center where
- ! the kepler temperature may be slightly higher than the
- ! isentropic, but we are still not done with isentropic.
- ! i_isentropic is an index that keeps track of when we switch
- ! to the original kepler model "for real". This is used for
- ! diagnostics. We require the temperature to have dropped by
- ! 10% from the central value at least...
- if (i_isentropic == -1 .and. &
- model_isentropic_hse(i,itemp) < 0.9*max_temp) i_isentropic = i
-
- model_hybrid_hse(i,itemp) = model_kepler_hse(i,itemp)
- endif
-
- enddo
-
- ! the outer part of the star will be using the original kepler
- ! temperature structure. Because the hybrid model might hit the
- ! fluff region earlier or later than the kepler model, reset the
- ! temperatures in the fluff region to the last valid kepler zone.
- model_hybrid_hse(index_hse_fluff:,itemp) = model_kepler_hse(index_hse_fluff-1,itemp)
-
-
- ! compute the enclosed mass
- M_enclosed(1) = FOUR3RD*M_PI*delx**3*model_hybrid_hse(1,idens)
-
- fluff = .FALSE.
-
- do i = 2, nx
-
- ! use previous zone as initial guess for T, rho
- dens_zone = model_hybrid_hse(i-1,idens)
- temp_zone = model_hybrid_hse(i-1,itemp)
-
- xn(:) = model_hybrid_hse(i,ispec:nvar)
-
- ! compute the gravitational acceleration on the interface between zones
- ! i-1 and i
- g_zone = -Gconst*M_enclosed(i-1)/(xznr(i-1)*xznr(i-1))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- do iter = 1, MAX_ITER
-
-
- ! HSE differencing
- p_want = model_hybrid_hse(i-1,ipres) + &
- delx*0.5_dp_t*(dens_zone + model_hybrid_hse(i-1,idens))*g_zone
-
- temp_zone = model_hybrid_hse(i,itemp)
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
- drho = (p_want - pres_zone)/(dpd - 0.5_dp_t*delx*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone <= low_density_cutoff) then
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
-
- ! update the thermodynamics in this zone
- model_hybrid_hse(i,idens) = dens_zone
- model_hybrid_hse(i,itemp) = temp_zone
- model_hybrid_hse(i,ipres) = pres_zone
- model_hybrid_hse(i,ientr) = eos_state%s
- model_hybrid_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- eint_hybrid = eint_hybrid + &
- dens_zone*eos_state%e*FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hybrid_hse(i,idens)
-
- enddo
-
-
-
-
-
-
- !===========================================================================
- ! output
- !===========================================================================
-
- !---------------------------------------------------------------------------
- ! kepler model
- !---------------------------------------------------------------------------
-
- ipos = index(model_file, '.raw')
- outfile = model_file(1:ipos-1) // '.hse'
-
- write(num,'(i8)') nx
-
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- print *, 'writing HSE Kepler model to ', trim(outfile)
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nx
- write (50,1001) "# num of variables = ", 3 + nspec
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
-1001 format(a, i5)
-1002 format(a)
-1003 format(a,a)
-
- do i = 1, nx
-
- write (50,1000) xzn_hse(i), model_kepler_hse(i,idens), model_kepler_hse(i,itemp), model_kepler_hse(i,ipres), &
- (model_kepler_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=50)
-
-
- ! compute the enclosed mass
- M_enclosed(1) = FOUR3RD*M_PI*delx**3*model_kepler_hse(1,idens)
-
- do i = 2, nx
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_kepler_hse(i,idens)
- enddo
-
- print *, 'total mass = ', real(M_enclosed(nx)), ' g = ', real(M_enclosed(nx)/M_solar), ' solar masses'
-
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
- dpdr = (model_kepler_hse(i,ipres) - model_kepler_hse(i-1,ipres))/delx
- rhog = HALF*(model_kepler_hse(i,idens) + model_kepler_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_kepler_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
- !---------------------------------------------------------------------------
- ! isentropic model
- !---------------------------------------------------------------------------
-
- ipos = index(model_file, '.raw')
- outfile = model_file(1:ipos-1) // '.isentropic.hse'
-
- write(num,'(i8)') nx
-
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- print *, 'writing HSE isentropic model to ', trim(outfile)
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nx
- write (50,1001) "# num of variables = ", 3 + nspec
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
- do i = 1, nx
-
- write (50,1000) xzn_hse(i), model_isentropic_hse(i,idens), model_isentropic_hse(i,itemp), model_isentropic_hse(i,ipres), &
- (model_isentropic_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=50)
-
-
- ! compute the enclosed mass
- M_enclosed(1) = FOUR3RD*M_PI*delx**3*model_isentropic_hse(1,idens)
-
- do i = 2, nx
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_isentropic_hse(i,idens)
- enddo
-
- print *, 'total mass = ', real(M_enclosed(nx)), ' g = ', real(M_enclosed(nx)/M_solar), ' solar masses'
-
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
- dpdr = (model_isentropic_hse(i,ipres) - model_isentropic_hse(i-1,ipres))/delx
- rhog = HALF*(model_isentropic_hse(i,idens) + model_isentropic_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_isentropic_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
-
- !---------------------------------------------------------------------------
- ! hybrid model
- !---------------------------------------------------------------------------
-
- ipos = index(model_file, '.raw')
- outfile = model_file(1:ipos-1) // '.hybrid.hse'
-
- write(num,'(i8)') nx
-
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- print *, 'writing HSE hybrid model to ', trim(outfile)
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nx
- write (50,1001) "# num of variables = ", 3 + nspec
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
- do i = 1, nx
-
- write (50,1000) xzn_hse(i), model_hybrid_hse(i,idens), model_hybrid_hse(i,itemp), model_hybrid_hse(i,ipres), &
- (model_hybrid_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=50)
-
-
- ! compute the enclosed mass
- M_enclosed(1) = FOUR3RD*M_PI*delx**3*model_hybrid_hse(1,idens)
-
- do i = 2, nx
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hybrid_hse(i,idens)
- enddo
-
- print *, 'total mass = ', real(M_enclosed(nx)), ' g = ', real(M_enclosed(nx)/M_solar), ' solar masses'
- print *, 'mass of convective region = ', real(M_enclosed(i_isentropic)), ' g = ', &
- real(M_enclosed(i_isentropic)/M_solar), ' solar masses'
- print *, 'radius of convective region = ', real(xzn_hse(i_isentropic)), ' cm'
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
- dpdr = (model_hybrid_hse(i,ipres) - model_hybrid_hse(i-1,ipres))/delx
- rhog = HALF*(model_hybrid_hse(i,idens) + model_hybrid_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_hybrid_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
-
-
-
- ! output the entropy
-
- outfile = model_file(1:ipos-1) // '.entropy'
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- open (unit=60, file=outfile, status="unknown")
-
- do i = 1, nx
- write (60,1000) xzn_hse(i), model_kepler_hse(i,ientr)
- enddo
-
- close (unit=60)
-
-
- ! compute the mass enclosed inside the anelastic_cutoff
- M_enclosed_anel = FOUR3RD*M_PI*delx**3*model_hybrid_hse(1,idens)
- do i = 2, nx
- if (model_hybrid_hse(i,idens) >= anelastic_cutoff) then
- M_enclosed_anel = M_enclosed_anel + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hybrid_hse(i,idens)
- else
- exit
- endif
- enddo
-
- print *, ' '
- print *, 'mass within anelastic_cutoff (', real(anelastic_cutoff), ') =', &
- real(M_enclosed_anel/M_solar), 'solar masses'
-
-
- ! compute the central sound speed
- print *, 'sound speed at center of star = ', model_hybrid_hse(1,isndspd)
-
-
- ! compute the gravitational potential energy
- M_center = FOUR3RD*M_PI*xzn_hse(1)**3*model_hybrid_hse(1,idens)
-
- ! dU = - G M dM / r; dM = 4 pi r**2 rho dr --> dU = - 4 pi G r rho dr
- grav_ener = -FOUR*M_PI*Gconst*M_center*xzn_hse(1)*model_hybrid_hse(1,idens)*(xznr(1) - xznl(1))
-
-
- do i = 2, nx
- if (model_hybrid_hse(i,idens) >= anelastic_cutoff) then
- M_center = M_center + &
- FOUR3RD*M_PI*(xzn_hse(i) - xznl(i)) * &
- (xzn_hse(i)**2 +xznl(i)*xzn_hse(i) + xznl(i)**2)*model_hybrid_hse(i,idens) + &
- FOUR3RD*M_PI*(xznr(i-1) - xzn_hse(i-1)) * &
- (xznr(i-1)**2 +xzn_hse(i-1)*xznr(i-1) + xzn_hse(i-1)**2)*model_hybrid_hse(i-1,idens)
-
- ! dU = - G M dM / r; dM = 4 pi r**2 rho dr --> dU = - 4 pi G r rho dr
- grav_ener = grav_ener - &
- FOUR*M_PI*Gconst*M_center*xzn_hse(i)*model_hybrid_hse(i,idens)*(xznr(i) - xznl(i))
- else
- exit
- endif
- enddo
-
- print *, "gravitational potential energy = ", grav_ener
- print *, "internal energy = ", eint_hybrid
-
-end program init_1d
-
-
-
-
-
- function interpolate(r, npts, model_r, model_var)
-
- use bl_types
-
- implicit none
-
-
- ! given the array of model coordinates (model_r), and variable (model_var),
- ! find the value of model_var at point r using linear interpolation.
- ! Eventually, we can do something fancier here.
-
- real(kind=dp_t) :: interpolate
- real(kind=dp_t), intent(in) :: r
- integer :: npts
- real(kind=dp_t), dimension(npts) :: model_r, model_var
-
- real(kind=dp_t) :: slope
- real(kind=dp_t) :: minvar, maxvar
-
- integer :: i, id
-
- ! find the location in the coordinate array where we want to interpolate
- do i = 1, npts
- if (model_r(i) >= r) exit
- enddo
-
- id = i
-
- if (id == 1) then
-
- slope = (model_var(id+1) - model_var(id))/(model_r(id+1) - model_r(id))
- interpolate = slope*(r - model_r(id)) + model_var(id)
-
- ! safety check to make sure interpolate lies within the bounding points
- !minvar = min(model_var(id+1),model_var(id))
- !maxvar = max(model_var(id+1),model_var(id))
- !interpolate = max(interpolate,minvar)
- !interpolate = min(interpolate,maxvar)
-
- else
-
- slope = (model_var(id) - model_var(id-1))/(model_r(id) - model_r(id-1))
- interpolate = slope*(r - model_r(id)) + model_var(id)
-
- ! safety check to make sure interpolate lies within the bounding points
- minvar = min(model_var(id),model_var(id-1))
- maxvar = max(model_var(id),model_var(id-1))
- interpolate = max(interpolate,minvar)
- interpolate = min(interpolate,maxvar)
-
- endif
-
- return
-
- end function interpolate
diff --git a/Util/initial_models/kepler_hybrid/init_1d_irreg.f90 b/Util/initial_models/kepler_hybrid/init_1d_irreg.f90
deleted file mode 100644
index 989cb2fed..000000000
--- a/Util/initial_models/kepler_hybrid/init_1d_irreg.f90
+++ /dev/null
@@ -1,1387 +0,0 @@
-!! Take an initial model from a Lagrangian code and put it onto
-!! a uniform grid and make sure that it is happy with the EOS in
-!! our code. The output is a .hse file that can be read directly
-!! by Maestro.
-!!
-!! The model is placed into HSE by the following differencing:
-!!
-!! (1/dr) [ _i -
_{i-1} ] = (1/2) [ _i + _{i-1} ] g
-!!
-!!
-!! We take the temperature structure directly from the original
-!! initial model. We adjust the density and pressure according to
-!! HSE using the EOS.
-!!
-!!***
-
-program init_1d_irreg
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use eos_module, only: eos, eos_init
- use eos_type_module, only : eos_t, eos_input_rt
- use network
- use fundamental_constants_module
- use extern_probin_module, only: use_eos_coulomb
-
- implicit none
-
- integer :: i, j, n
-
- real (kind=dp_t), allocatable :: xzn_hse(:), xznl(:), xznr(:)
- real (kind=dp_t), allocatable :: M_enclosed(:)
- real (kind=dp_t), allocatable :: model_kepler_hse(:,:)
- real (kind=dp_t), allocatable :: model_isentropic_hse(:,:)
- real (kind=dp_t), allocatable :: model_hybrid_hse(:,:)
- real (kind=dp_t), allocatable :: entropy_want(:)
-
- integer, parameter :: nx = 640
- integer, parameter :: nr = (3*((nx/5)/2-0.5_dp_t)*((nx/5)/2-0.5_dp_t)-0.75_dp_t)/2.0_dp_t;
-
- ! define convenient indices for the scalars
- integer, parameter :: nvar = 5 + nspec
- integer, parameter :: idens = 1, &
- itemp = 2, &
- ipres = 3, &
- ientr = 4, &
- isndspd = 5, &
- ispec = 6
-
- real (kind=dp_t), save :: xmin, xmax, delx, delr
- real (kind=dp_t), allocatable :: delrl(:), delrr(:)
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone, entropy
-
- real (kind=dp_t) :: A, B, dAdT, dAdrho, dBdT, dBdrho
- real (kind=dp_t) :: dpd, dpt, dsd, dst
-
- real (kind=dp_t) :: central_density
-
- real (kind=dp_t) :: p_want, drho, dtemp
-
- real (kind=dp_t) :: g_zone
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- real (kind=dp_t), parameter :: TOL = 1.e-10
-
- integer, parameter :: MAX_ITER = 250
-
- integer :: iter, iter_dens
-
- integer :: igood
- real (kind=dp_t) :: slope
-
- logical :: converged_hse, converged_central_density, fluff, isentropic
-
- real (kind=dp_t) :: max_temp
-
- integer :: index_hse_fluff
-
- real (kind=dp_t), dimension(nspec) :: xn
-
- real (kind=dp_t), save :: low_density_cutoff, temp_fluff, temp_fluff_cutoff, smallx
-
- integer, parameter :: MAX_VARNAME_LENGTH=80
- integer :: npts_model, nvars_model_file
-
- real(kind=dp_t), allocatable :: base_state(:,:), base_r(:)
- real(kind=dp_t), allocatable :: vars_stored(:)
- character(len=MAX_VARNAME_LENGTH), allocatable :: varnames_stored(:)
- logical :: found
-
- integer :: ipos
- character (len=256) :: header_line, model_file, outfile
- character (len=8) num
-
- real(kind=dp_t) :: interpolate
- real(kind=dp_t) :: sum
- real(kind=dp_t) :: rfrac
-
- integer :: ibegin
- integer :: i_isentropic
-
- real(kind=dp_t), parameter :: M_solar = 1.98892d33
- real(kind=dp_t) :: anelastic_cutoff = 3.e6 ! this is for diagnostics only -- not used in the HSEing
- real(kind=dp_t) :: M_enclosed_anel
- real(kind=dp_t) :: grav_ener, M_center
- real(kind=dp_t) :: eint_hybrid
-
- type (eos_t) :: eos_state
-
- smallx = 1.d-10
-
- ! set the parameters
- model_file = "kepler_new_6.25e8.raw"
-
- xmin = 0_dp_t
- xmax = 5.d8
-
- low_density_cutoff =1.d-4
-
- ! temp_fluff_cutoff is the density below which we hold the temperature
- ! constant for the kepler model
-
- ! MAESTRO
- temp_fluff_cutoff = 1.d-4
-
- ! CASTRO
- ! temp_fluff_cutoff = 1.d3
-
- temp_fluff = 5.d6
-
- ! this comes in via extern_probin_module -- override the default
- ! here if we want
- use_eos_coulomb = .true.
-
-
- ! initialize the EOS and network
- call eos_init()
- call network_init()
-
- !===========================================================================
- ! Create a 1-d uniform grid that is identical to the mesh that we are
- ! mapping onto, and then we want to force it into HSE on that mesh.
- !===========================================================================
-
- ! allocate storage
- allocate(xzn_hse(nr))
- allocate(xznl(nr))
- allocate(xznr(nr))
- allocate(model_kepler_hse(nr,nvar))
- allocate(model_isentropic_hse(nr,nvar))
- allocate(model_hybrid_hse(nr,nvar))
- allocate(M_enclosed(nr))
- allocate(entropy_want(nr))
- allocate(delrl(nr))
- allocate(delrr(nr))
-
- ! compute the coordinates of the new gridded function
- delx = (xmax - xmin) / dble(nx/5)
-
- do i = 1, nr
- if (i .eq. 1) then
- ! set the first edge node to xmin
- xznl(i) = xmin
- else
- xznl(i) = xmin + sqrt(0.75_dp_t + 2.0_dp_t*(i - 1.5_dp_t))*delx
- end if
-
- xznr(i) = xmin + sqrt(0.75_dp_t + 2.0_dp_t*(i - 0.5_dp_t))*delx
- xzn_hse(i) = xmin + sqrt( 0.75_dp_t + 2.0_dp_t*(i - 1.0_dp_t) )*delx ! cell center
- delrl(i) = xzn_hse(i) - xznl(i)
- delrr(i) = xznr(i) - xzn_hse(i)
- enddo
-
-
-
- !===========================================================================
- ! read in the Kepler model
- !===========================================================================
-
- ! Open the model file and read in the header
- !
- ! the model file is assumed to be of the follow form:
- ! # npts = 178
- ! # num of variables = 6
- ! # density
- ! # temperature
- ! # pressure
- ! # carbon-12
- ! # oxygen-16
- ! # magnesium-24
- ! 195312.5000 5437711139. 8805500.952 .4695704813E+28 0.3 0.7 0
- ! 585937.5000 5410152416. 8816689.836 0.4663923963E+28 0.3 0.7 0
- !
- ! we read in the number of variables and their order and use this to map
- ! them into the base_state array. We ignore anything other than density,
- ! temperature, pressure and composition.
- !
- ! Presently, we take density, temperature, and composition as the
- ! independent variables and use them to define the thermodynamic state.
- !
- ! composition is assumed to be in terms of mass fractions
-
-
- open(99,file=model_file)
-
- ! the first line has the number of points in the model
- read (99, '(a256)') header_line
- ipos = index(header_line, '=') + 1
- read (header_line(ipos:),*) npts_model
-
- print *, npts_model, ' points found in the initial model file'
-
- ! now read in the number of variables
- read (99, '(a256)') header_line
- ipos = index(header_line, '=') + 1
- read (header_line(ipos:),*) nvars_model_file
-
- print *, nvars_model_file, ' variables found in the initial model file'
-
- allocate (vars_stored(nvars_model_file))
- allocate (varnames_stored(nvars_model_file))
-
- ! now read in the names of the variables
- do i = 1, nvars_model_file
- read (99, '(a256)') header_line
- ipos = index(header_line, '#') + 1
- varnames_stored(i) = trim(adjustl(header_line(ipos:)))
- enddo
-
- ! allocate storage for the model data
- allocate (base_state(npts_model, nvar))
- allocate (base_r(npts_model))
-
- do i = 1, npts_model
- read(99,*) base_r(i), (vars_stored(j), j = 1, nvars_model_file)
-
- base_state(i,:) = ZERO
-
- do j = 1, nvars_model_file
-
- found = .false.
-
- select case (trim(varnames_stored(j)))
-
- case ("density")
- base_state(i,idens) = vars_stored(j)
- found = .true.
-
- case ("temperature")
- base_state(i,itemp) = vars_stored(j)
- found = .true.
-
- case ("pressure")
- base_state(i,ipres) = vars_stored(j)
- found = .true.
-
- case default
-
- ! check if they are species
- n = network_species_index(trim(varnames_stored(j)))
- if (n > 0) then
- base_state(i,ispec-1+n) = vars_stored(j)
- found = .true.
- endif
-
- end select
-
- if (.NOT. found) then
- print *, 'ERROR: variable not found: ', varnames_stored(j)
- endif
-
- enddo
-
- enddo
-
-
- open (unit=50, file="model.orig", status="unknown")
-
- write (50,*) "# initial model as read in"
-
- do i = 1, npts_model
- write (50,1000) base_r(i), (base_state(i,j), j = 1, nvar)
- enddo
-
- close (50)
-
-
-
- !===========================================================================
- ! put the model onto our new uniform grid
- !===========================================================================
-
- igood = -1
-
- do i = 1, nr
-
- do n = 1, nvar
-
- if (xzn_hse(i) < base_r(npts_model)) then
-
- model_kepler_hse(i,n) = interpolate(xzn_hse(i), npts_model, &
- base_r, base_state(:,n))
-
- igood = i
- else
-
- !if (n == itemp) then
-
- ! linearly interpolate the last good Kepler zones
- ! slope = (model_kepler_hse(igood,itemp) - model_kepler_hse(igood-1,itemp))/ &
- ! (xzn_hse(igood) - xzn_hse(igood-1))
- !
- ! model_kepler_hse(i,n) = max(temp_fluff, &
- ! model_kepler_hse(igood,itemp) + slope*(xzn_hse(i) - xzn_hse(igood)))
-
- !else
- ! use a zero-gradient at the top of the initial model if our domain is
- ! larger than the model's domain.
-
- model_kepler_hse(i,n) = base_state(npts_model,n)
- !endif
- endif
-
- enddo
-
-
- ! make sure that the species (mass fractions) sum to 1
- sum = 0.0_dp_t
- do n = ispec,ispec-1+nspec
- model_kepler_hse(i,n) = max(model_kepler_hse(i,n),smallx)
- sum = sum + model_kepler_hse(i,n)
- enddo
-
- do n = ispec,ispec-1+nspec
- model_kepler_hse(i,n) = model_kepler_hse(i,n)/sum
- enddo
-
- enddo
-
-
-
- open (unit=30, file="model.nonuniform", status="unknown")
-
-1000 format (1x, 12(g26.16, 1x))
-
- write (30,*) "# initial model just after putting onto a non-uniform grid"
-
- do i = 1, nr
-
- write (30,1000) xzn_hse(i), model_kepler_hse(i,idens), model_kepler_hse(i,itemp), &
- model_kepler_hse(i,ipres), (model_kepler_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=30)
-
- !===========================================================================
- ! iterate to find the central density
- !===========================================================================
-
- ! because the Kepler model likely begins at a larger radius than our first
- ! HSE model zone, simple interpolation will not do a good job. We want to
- ! integrate in from the zone that best matches the first Kepler model zone,
- ! assuming HSE and constant entropy.
-
-
- ! find the zone in the nonconstant gridded model that corresponds to the
- ! first zone of the original model
- ibegin = -1
- do i = 1, nr
- if (xzn_hse(i) >= base_r(1)) then
- ibegin = i
- exit
- endif
- enddo
-
- print *, 'ibegin = ', ibegin
-
-
- ! store the central density. We will iterate until the central density
- ! converges
- central_density = model_kepler_hse(1,idens)
- print *, 'interpolated central density = ', central_density
-
- delr = delrl(1) + delrr(1)
-
- do iter_dens = 1, max_iter
-
- ! compute the enclosed mass
- M_enclosed(1) = FOUR3RD*M_PI*delr**3*model_kepler_hse(1,idens)
-
- do i = 2, ibegin
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_kepler_hse(i,idens)
- enddo
-
-
- ! now start at ibegin and integrate inward
- eos_state%T = model_kepler_hse(ibegin,itemp)
- eos_state%rho = model_kepler_hse(ibegin,idens)
- eos_state%xn(:) = model_kepler_hse(ibegin,ispec:nvar)
-
- call eos(eos_input_rt, eos_state)
-
- model_kepler_hse(ibegin,ipres) = eos_state%p
- model_kepler_hse(ibegin,ientr) = eos_state%s
- model_kepler_hse(ibegin,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- entropy_want(:) = eos_state%s
-
-
- do i = ibegin-1, 1, -1
-
-
- ! as the initial guess for the temperature and density, use
- ! the previous zone
- dens_zone = model_kepler_hse(i+1,idens)
- temp_zone = model_kepler_hse(i+1,itemp)
- xn(:) = model_kepler_hse(i,ispec:nvar)
-
- ! compute the gravitational acceleration on the interface between zones
- ! i and i+1
- g_zone = -Gconst*M_enclosed(i)/(xznr(i)*xznr(i))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- delr = delrr(i) + delrl(i+1)
- rfrac = delrl(i+1)/delr
-
- do iter = 1, MAX_ITER
-
- p_want = model_kepler_hse(i+1,ipres) - &
- delr*((ONE-rfrac)*dens_zone + rfrac*model_kepler_hse(i+1,idens))*g_zone
-
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_want(i) - entropy
-
- dAdT = -dpt
- dAdrho = -(ONE-rfrac)*delr*g_zone - dpd
- dBdT = -dst
- dBdrho = -dsd
-
- dtemp = (B - (dBdrho/dAdrho)*A)/ &
- ((dBdrho/dAdrho)*dAdT - dBdT)
-
- drho = -(A + dAdT*dtemp)/dAdrho
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- ! if (A < TOL .and. B < ETOL) then
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- ! update the thermodynamics in this zone
- model_kepler_hse(i,idens) = dens_zone
- model_kepler_hse(i,itemp) = temp_zone
- model_kepler_hse(i,ipres) = pres_zone
- model_kepler_hse(i,ientr) = eos_state%s
- model_kepler_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- enddo
-
- if (abs(model_kepler_hse(1,idens) - central_density) < TOL*central_density) then
- converged_central_density = .true.
- exit
- endif
-
- central_density = model_kepler_hse(1,idens)
-
- enddo
-
- if (.NOT. converged_central_density) then
- print *, 'ERROR: central density iterations did not converge'
- call bl_error('ERROR: non-convergence')
- endif
-
-
- print *, 'converged central density = ', model_kepler_hse(1,idens)
- print *, ' '
-
- !===========================================================================
- ! compute the full HSE model using our new central density and temperature,
- ! and the temperature structure as dictated by the Kepler model.
- !===========================================================================
-
- print *, 'putting Kepler model into HSE on our grid...'
-
- ! compute the enclosed mass
- delr = delrl(1) + delrr(1)
- M_enclosed(1) = FOUR3RD*M_PI*delr**3*model_kepler_hse(1,idens)
-
- fluff = .FALSE.
-
- do i = 2, nr
-
- ! use previous zone as initial guess for T, rho
- dens_zone = model_kepler_hse(i-1,idens)
- temp_zone = model_kepler_hse(i-1,itemp)
-
- xn(:) = model_kepler_hse(i,ispec:nvar)
-
- ! compute the gravitational acceleration on the interface between zones
- ! i-1 and i
- g_zone = -Gconst*M_enclosed(i-1)/(xznr(i-1)*xznr(i-1))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- delr = delrl(i) + delrr(i-1)
- rfrac = delrr(i-1)/delr
-
- do iter = 1, MAX_ITER
-
-
- ! HSE differencing
- p_want = model_kepler_hse(i-1,ipres) + &
- delr*((ONE-rfrac)*dens_zone + rfrac*model_kepler_hse(i-1,idens))*g_zone
-
- temp_zone = model_kepler_hse(i,itemp)
-
- if (model_kepler_hse(i-1,idens) .lt. temp_fluff_cutoff) then
- temp_zone = temp_fluff
- end if
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
- drho = (p_want - pres_zone)/(dpd - (ONE-rfrac)*delr*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- index_hse_fluff = i
- exit
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
-
- ! update the thermodynamics in this zone
- model_kepler_hse(i,idens) = dens_zone
- model_kepler_hse(i,itemp) = temp_zone
- model_kepler_hse(i,ipres) = pres_zone
- model_kepler_hse(i,ientr) = eos_state%s
- model_kepler_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_kepler_hse(i,idens)
-
- enddo
-
-
- !===========================================================================
- ! compute the alternate model using the same central density and
- ! temperature, but assuming that we are isentropic (and in HSE).
- !===========================================================================
-
- print *, 'creating isentropic model...'
-
- ! as an initial guess, use the Kepler HSE model
- model_isentropic_hse(:,:) = model_kepler_hse(:,:)
-
- entropy_want(:) = model_isentropic_hse(1,ientr)
-
- fluff = .false.
- isentropic = .true.
-
- ! keep track of the mass enclosed below the current zone
- delr = delrl(1) + delrr(1)
- M_enclosed(1) = FOUR3RD*M_PI*delr**3*model_isentropic_hse(1,idens)
-
- do i = 2, nr
-
- ! use previous zone as initial guess for T, rho
- dens_zone = model_isentropic_hse(i-1,idens)
- temp_zone = model_isentropic_hse(i-1,itemp)
-
- xn(:) = model_isentropic_hse(i,ispec:nvar)
-
- g_zone = -Gconst*M_enclosed(i-1)/(xznr(i-1)*xznr(i-1))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- delr = delrl(i) + delrr(i-1)
- rfrac = delrr(i-1)/delr
-
- do iter = 1, MAX_ITER
-
- if (isentropic) then
-
- p_want = model_isentropic_hse(i-1,ipres) + &
- delr*((ONE-rfrac)*dens_zone + rfrac*model_isentropic_hse(i-1,idens))*g_zone
-
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_want(i) - entropy
-
- dAdT = -dpt
- dAdrho = (ONE-rfrac)*delr*g_zone - dpd
- dBdT = -dst
- dBdrho = -dsd
-
- dtemp = (B - (dBdrho/dAdrho)*A)/ &
- ((dBdrho/dAdrho)*dAdT - dBdT)
-
- drho = -(A + dAdT*dtemp)/dAdrho
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- ! if (A < TOL .and. B < ETOL) then
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- else
-
- ! do isothermal
- p_want = model_isentropic_hse(i-1,ipres) + &
- delr*((ONE-rfrac)*dens_zone + rfrac*model_isentropic_hse(i-1,idens))*g_zone
-
- temp_zone = temp_fluff
-
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - (ONE-rfrac)*delr*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- isentropic = .false.
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p, s)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- ! update the thermodynamics in this zone
- model_isentropic_hse(i,idens) = dens_zone
- model_isentropic_hse(i,itemp) = temp_zone
- model_isentropic_hse(i,ipres) = pres_zone
- model_isentropic_hse(i,ientr) = eos_state%s
- model_isentropic_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i))* &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_isentropic_hse(i,idens)
-
- enddo
-
-
- !===========================================================================
- ! compute a hybrid model -- isentropic in the interior, Kepler's temperature
- ! structure outside.
- !===========================================================================
-
- print *, 'creating hybrid model...'
- print *, ' '
- eint_hybrid = 0.0
-
-
- max_temp = maxval(model_kepler_hse(:,itemp))
- i_isentropic = -1
- do i = 1, nr
- model_hybrid_hse(i,:) = model_isentropic_hse(i,:)
-
- if (model_kepler_hse(i,itemp) > model_isentropic_hse(i,itemp)) then
-
- ! there will be a few regions in the very, very center where
- ! the kepler temperature may be slightly higher than the
- ! isentropic, but we are still not done with isentropic.
- ! i_isentropic is an index that keeps track of when we switch
- ! to the original kepler model "for real". This is used for
- ! diagnostics. We require the temperature to have dropped by
- ! 10% from the central value at least...
- if (i_isentropic == -1 .and. &
- model_isentropic_hse(i,itemp) < 0.9*max_temp) i_isentropic = i
-
- model_hybrid_hse(i,itemp) = model_kepler_hse(i,itemp)
- endif
-
- enddo
-
- ! the outer part of the star will be using the original kepler
- ! temperature structure. Because the hybrid model might hit the
- ! fluff region earlier or later than the kepler model, reset the
- ! temperatures in the fluff region to the last valid kepler zone.
- model_hybrid_hse(index_hse_fluff:,itemp) = model_kepler_hse(index_hse_fluff-1,itemp)
-
-
- ! compute the enclosed mass
- delr = delrl(1) + delrr(1)
- M_enclosed(1) = FOUR3RD*M_PI*delr**3*model_hybrid_hse(1,idens)
-
- fluff = .FALSE.
-
- do i = 2, nr
-
- ! use previous zone as initial guess for T, rho
- dens_zone = model_hybrid_hse(i-1,idens)
- temp_zone = model_hybrid_hse(i-1,itemp)
-
- xn(:) = model_hybrid_hse(i,ispec:nvar)
-
- ! compute the gravitational acceleration on the interface between zones
- ! i-1 and i
- g_zone = -Gconst*M_enclosed(i-1)/(xznr(i-1)*xznr(i-1))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- delr = delrl(i) + delrr(i-1)
- rfrac = delrr(i-1)/delr
-
- do iter = 1, MAX_ITER
-
-
- ! HSE differencing
- p_want = model_hybrid_hse(i-1,ipres) + &
- delr*((ONE-rfrac)*dens_zone + rfrac*model_hybrid_hse(i-1,idens))*g_zone
-
- temp_zone = model_hybrid_hse(i,itemp)
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
- drho = (p_want - pres_zone)/(dpd - (ONE-rfrac)*delr*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone <= low_density_cutoff) then
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
-
- ! update the thermodynamics in this zone
- model_hybrid_hse(i,idens) = dens_zone
- model_hybrid_hse(i,itemp) = temp_zone
- model_hybrid_hse(i,ipres) = pres_zone
- model_hybrid_hse(i,ientr) = eos_state%s
- model_hybrid_hse(i,isndspd) = &
- sqrt(eos_state%gam1*eos_state%p/eos_state%rho)
-
- eint_hybrid = eint_hybrid + &
- dens_zone*eos_state%e*FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hybrid_hse(i,idens)
-
- enddo
-
-
-
-
-
-
- !===========================================================================
- ! output
- !===========================================================================
-
- !---------------------------------------------------------------------------
- ! kepler model
- !---------------------------------------------------------------------------
-
- ipos = index(model_file, '.raw')
- outfile = model_file(1:ipos-1) // '.hse'
-
- write(num,'(i8)') nr
-
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- print *, 'writing HSE Kepler model to ', trim(outfile)
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nr
- write (50,1001) "# num of variables = ", 3 + nspec
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
-1001 format(a, i5)
-1002 format(a)
-1003 format(a,a)
-
- do i = 1, nr
-
- write (50,1000) xzn_hse(i), model_kepler_hse(i,idens), model_kepler_hse(i,itemp), model_kepler_hse(i,ipres), &
- (model_kepler_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=50)
-
-
- ! compute the enclosed mass
- delr = delrl(1) + delrr(1)
- M_enclosed(1) = FOUR3RD*M_PI*delr**3*model_kepler_hse(1,idens)
-
- do i = 2, nr
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_kepler_hse(i,idens)
- enddo
-
- print *, 'total mass = ', real(M_enclosed(nr)), ' g = ', real(M_enclosed(nr)/M_solar), ' solar masses'
-
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nr-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
-
- delr = delrl(i) + delrr(i-1)
- dpdr = (model_kepler_hse(i,ipres) - model_kepler_hse(i-1,ipres))/delr
-
- rfrac = delrr(i-1)/delr
- rhog = ((1.0_dp_t-rfrac)*model_kepler_hse(i,idens) + rfrac*model_kepler_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_kepler_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
- !---------------------------------------------------------------------------
- ! isentropic model
- !---------------------------------------------------------------------------
-
- ipos = index(model_file, '.raw')
- outfile = model_file(1:ipos-1) // '.isentropic.hse'
-
- write(num,'(i8)') nr
-
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- print *, 'writing HSE isentropic model to ', trim(outfile)
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nr
- write (50,1001) "# num of variables = ", 3 + nspec
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
- do i = 1, nr
-
- write (50,1000) xzn_hse(i), model_isentropic_hse(i,idens), model_isentropic_hse(i,itemp), model_isentropic_hse(i,ipres), &
- (model_isentropic_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=50)
-
-
- ! compute the enclosed mass
- delr = delrl(1) + delrr(1)
- M_enclosed(1) = FOUR3RD*M_PI*delr**3*model_isentropic_hse(1,idens)
-
- do i = 2, nr
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_isentropic_hse(i,idens)
- enddo
-
- print *, 'total mass = ', real(M_enclosed(nr)), ' g = ', real(M_enclosed(nr)/M_solar), ' solar masses'
-
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nr-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
-
- delr = delrl(i) + delrr(i-1)
- dpdr = (model_isentropic_hse(i,ipres) - model_isentropic_hse(i-1,ipres))/delr
-
- rfrac = delrr(i-1)/delr
- rhog = ((1.0_dp_t-rfrac)*model_isentropic_hse(i,idens) + rfrac*model_isentropic_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_isentropic_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
-
- !---------------------------------------------------------------------------
- ! hybrid model
- !---------------------------------------------------------------------------
-
- ipos = index(model_file, '.raw')
- outfile = model_file(1:ipos-1) // '.hybrid.hse'
-
- write(num,'(i8)') nr
-
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- print *, 'writing HSE hybrid model to ', trim(outfile)
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nr
- write (50,1001) "# num of variables = ", 3 + nspec
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
- do i = 1, nr
-
- write (50,1000) xzn_hse(i), model_hybrid_hse(i,idens), model_hybrid_hse(i,itemp), model_hybrid_hse(i,ipres), &
- (model_hybrid_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- close (unit=50)
-
-
- ! compute the enclosed mass
- delr = delrl(1) + delrr(1)
- M_enclosed(1) = FOUR3RD*M_PI*delr**3*model_hybrid_hse(1,idens)
-
- do i = 2, nr
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hybrid_hse(i,idens)
- enddo
-
- print *, 'total mass = ', real(M_enclosed(nr)), ' g = ', real(M_enclosed(nr)/M_solar), ' solar masses'
- print *, 'mass of convective region = ', real(M_enclosed(i_isentropic)), ' g = ', &
- real(M_enclosed(i_isentropic)/M_solar), ' solar masses'
- print *, 'radius of convective region = ', real(xzn_hse(i_isentropic)), ' cm'
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nr-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
-
- delr = delrl(i) + delrr(i-1)
- dpdr = (model_hybrid_hse(i,ipres) - model_hybrid_hse(i-1,ipres))/delr
-
- rfrac = delrr(i-1)/delr
- rhog = ((1.0_dp_t-rfrac)*model_hybrid_hse(i,idens) + rfrac*model_hybrid_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_hybrid_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
-
-
-
- ! output the entropy
-
- outfile = model_file(1:ipos-1) // '.entropy'
- outfile = trim(outfile) // '.' // trim(adjustl(num))
-
- open (unit=60, file=outfile, status="unknown")
-
- do i = 1, nr
- write (60,1000) xzn_hse(i), model_kepler_hse(i,ientr)
- enddo
-
- close (unit=60)
-
-
- ! compute the mass enclosed inside the anelastic_cutoff
- delr = delrl(1) + delrr(1)
- M_enclosed_anel = FOUR3RD*M_PI*delr**3*model_hybrid_hse(1,idens)
- do i = 2, nr
- if (model_hybrid_hse(i,idens) >= anelastic_cutoff) then
- M_enclosed_anel = M_enclosed_anel + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i)) * &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hybrid_hse(i,idens)
- else
- exit
- endif
- enddo
-
- print *, ' '
- print *, 'mass within anelastic_cutoff (', real(anelastic_cutoff), ') =', &
- real(M_enclosed_anel/M_solar), 'solar masses'
-
-
- ! compute the central sound speed
- print *, 'sound speed at center of star = ', model_hybrid_hse(1,isndspd)
-
-
- ! compute the gravitational potential energy
- M_center = FOUR3RD*M_PI*xzn_hse(1)**3*model_hybrid_hse(1,idens)
-
- ! dU = - G M dM / r; dM = 4 pi r**2 rho dr --> dU = - 4 pi G r rho dr
- grav_ener = -FOUR*M_PI*Gconst*M_center*xzn_hse(1)*model_hybrid_hse(1,idens)*(xznr(1) - xznl(1))
-
-
- do i = 2, nr
- if (model_hybrid_hse(i,idens) >= anelastic_cutoff) then
- M_center = M_center + &
- FOUR3RD*M_PI*(xzn_hse(i) - xznl(i)) * &
- (xzn_hse(i)**2 +xznl(i)*xzn_hse(i) + xznl(i)**2)*model_hybrid_hse(i,idens) + &
- FOUR3RD*M_PI*(xznr(i-1) - xzn_hse(i-1)) * &
- (xznr(i-1)**2 +xzn_hse(i-1)*xznr(i-1) + xzn_hse(i-1)**2)*model_hybrid_hse(i-1,idens)
-
- ! dU = - G M dM / r; dM = 4 pi r**2 rho dr --> dU = - 4 pi G r rho dr
- grav_ener = grav_ener - &
- FOUR*M_PI*Gconst*M_center*xzn_hse(i)*model_hybrid_hse(i,idens)*(xznr(i) - xznl(i))
- else
- exit
- endif
- enddo
-
- print *, "gravitational potential energy = ", grav_ener
- print *, "internal energy = ", eint_hybrid
-
-end program init_1d_irreg
-
-
-
-
-
- function interpolate(r, npts, model_r, model_var)
-
- use bl_types
-
- implicit none
-
-
- ! given the array of model coordinates (model_r), and variable (model_var),
- ! find the value of model_var at point r using linear interpolation.
- ! Eventually, we can do something fancier here.
-
- real(kind=dp_t) :: interpolate
- real(kind=dp_t), intent(in) :: r
- integer :: npts
- real(kind=dp_t), dimension(npts) :: model_r, model_var
-
- real(kind=dp_t) :: slope
- real(kind=dp_t) :: minvar, maxvar
-
- integer :: i, id
-
- ! find the location in the coordinate array where we want to interpolate
- do i = 1, npts
- if (model_r(i) >= r) exit
- enddo
-
- id = i
-
- if (id == 1) then
-
- slope = (model_var(id+1) - model_var(id))/(model_r(id+1) - model_r(id))
- interpolate = slope*(r - model_r(id)) + model_var(id)
-
- ! safety check to make sure interpolate lies within the bounding points
- !minvar = min(model_var(id+1),model_var(id))
- !maxvar = max(model_var(id+1),model_var(id))
- !interpolate = max(interpolate,minvar)
- !interpolate = min(interpolate,maxvar)
-
- else
-
- slope = (model_var(id) - model_var(id-1))/(model_r(id) - model_r(id-1))
- interpolate = slope*(r - model_r(id)) + model_var(id)
-
- ! safety check to make sure interpolate lies within the bounding points
- minvar = min(model_var(id),model_var(id-1))
- maxvar = max(model_var(id),model_var(id-1))
- interpolate = max(interpolate,minvar)
- interpolate = min(interpolate,maxvar)
-
- endif
-
- return
-
- end function interpolate
diff --git a/Util/initial_models/kepler_hybrid/kepler_new_6.25e8.dat b/Util/initial_models/kepler_hybrid/kepler_new_6.25e8.dat
deleted file mode 100644
index 30e931ccf..000000000
--- a/Util/initial_models/kepler_hybrid/kepler_new_6.25e8.dat
+++ /dev/null
@@ -1,180 +0,0 @@
-# VERSION 10104 -- Thu Aug 27 17:55:20 2009 UTC -- created by woosley on banzai.ucolick.org from file /data/woosley/banzai/u/woosley/cdef/fudgc#t8eq625
- grid cell outer total mass cell outer radius cell outer velocity cell density cell temperature cell pressure cell specific energy cell specific entropy cell angular velocity cell A_bar cell Y_e stability NETWORK neutrons H1 He3 He4 C12 N14 O16 Ne20 Mg24 Si28 S32 Ar36 Ca40 Ti44 Cr48 Fe52 Fe54 Ni56 Fe56 'Fe'
- 1: 9.9999999999607598E+28 2.0831459844146401E+06 2.2991004949187746E+00 2.6409019248480692E+09 6.2496973682955909E+08 1.7729710406238415E+27 1.7943224964775365E+18 8.7243801861083381E-01 0.0000000000000000E+00 1.3738108630910947E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0951726619646424E-12 4.9695993464355021E-01 0.0000000000000000E+00 4.9800451975916810E-01 5.0158692573828191E-03 1.9673522275774586E-05 2.8125205512099273E-09 7.6846102673089186E-16 1.2341663759085211E-23 3.8945140394400762E-33 2.1678942834048940E-44 1.2675421733394288E-57 4.1842792207069614E-72 0.0000000000000000E+00 6.8822849405278371E-90 --- ---
- 2: 2.4523015847725093E+29 2.8099754690829176E+06 3.1012413413365452E+00 2.6370595885716796E+09 6.2442569729721022E+08 1.7695149825654912E+27 1.7933452362916063E+18 8.7246227544185073E-01 0.0000000000000000E+00 1.3738108008423149E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0922591887180706E-12 4.9696001384214056E-01 0.0000000000000000E+00 4.9800457200591092E-01 5.0157384314472066E-03 1.9672903137683499E-05 2.8122640125595853E-09 7.6836090615644264E-16 1.2339222210166360E-23 3.8934298170030087E-33 2.1670112518819848E-44 1.2667765433896677E-57 4.1809196684061470E-72 0.0000000000000000E+00 6.8755093579215613E-90 --- ---
- 3: 4.4308952902951118E+29 3.4235596900334051E+06 3.7783763248483271E+00 2.6330758682181296E+09 6.2386108185022426E+08 1.7659335465012540E+27 1.7923310208541509E+18 8.7248744845032267E-01 0.0000000000000000E+00 1.3738107233545646E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0886066425671325E-12 4.9696011242928001E-01 0.0000000000000000E+00 4.9800463704223519E-01 5.0155755797420543E-03 1.9672131700999492E-05 2.8119456538454690E-09 7.6823672782615803E-16 1.2336199021157816E-23 3.8920897581864098E-33 2.1659230451067171E-44 1.2658368694517938E-57 4.1768129946937264E-72 0.0000000000000000E+00 6.8672563719706502E-90 --- ---
- 4: 6.9611778106595762E+29 3.9812761894107144E+06 4.3938312914318329E+00 2.6287805416016064E+09 6.2325174344542372E+08 1.7620740188396826E+27 1.7912363357714542E+18 8.7251462648218581E-01 0.0000000000000000E+00 1.3738106293465377E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0841410731939089E-12 4.9696023203523665E-01 0.0000000000000000E+00 4.9800471594313511E-01 5.0153780101408491E-03 1.9671194834895950E-05 2.8115607098958859E-09 7.6808666654338726E-16 1.2332552258392939E-23 3.8904764721398215E-33 2.1646170719972039E-44 1.2647140796874316E-57 4.1719269518822841E-72 0.0000000000000000E+00 6.8574736772166765E-90 --- ---
- 5: 9.9999999999953474E+29 4.4938259837549161E+06 4.9594182189219751E+00 2.6242204473153596E+09 6.2260425662937510E+08 1.7579789155647876E+27 1.7900728795385912E+18 8.7254352623100051E-01 0.0000000000000000E+00 1.3738105203961679E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0789225471406816E-12 4.9696037065249410E-01 0.0000000000000000E+00 4.9800480738379616E-01 5.0151490396499890E-03 1.9670107857085167E-05 2.8111161788862878E-09 7.6791348496219724E-16 1.2328351712731255E-23 3.8886220873799196E-33 2.1631209329493808E-44 1.2634337449684304E-57 4.1663801681257169E-72 0.0000000000000000E+00 6.8464108337205827E-90 --- ---
- 6: 1.3428633252745263E+30 4.9596415520723276E+06 5.4734096854036558E+00 2.6195309990321012E+09 6.2193777500890696E+08 1.7537701531026699E+27 1.7888750179700093E+18 8.7257329578423548E-01 0.0000000000000000E+00 1.3738104014617237E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0731761042771851E-12 4.9696052197272722E-01 0.0000000000000000E+00 4.9800490720243051E-01 5.0148990892294560E-03 1.9668919899274158E-05 2.8106327253400799E-09 7.6772525959259369E-16 1.2323795372918577E-23 3.8866149759229512E-33 2.1615071384021480E-44 1.2620592759287251E-57 4.1604524831554852E-72 0.0000000000000000E+00 6.8346338569315455E-90 --- ---
- 7: 1.7264416518296091E+30 5.3949069858569233E+06 5.9536665848060748E+00 2.6147606573500462E+09 6.2125917806081617E+08 1.7494913986408206E+27 1.7876550472424622E+18 8.7260363547834396E-01 0.0000000000000000E+00 1.3738102743653322E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0669813714330767E-12 4.9696068367768920E-01 0.0000000000000000E+00 4.9800501386952517E-01 5.0146319886535517E-03 1.9667648939619201E-05 2.8101180330824736E-09 7.6752499627242375E-16 1.2318957272168640E-23 3.8844883136123004E-33 2.1598030482580490E-44 1.2606146953711893E-57 4.1542498658354471E-72 0.0000000000000000E+00 6.8223563027563727E-90 --- ---
- 8: 2.1519480749731376E+30 5.8082034809508231E+06 6.4096590706255112E+00 2.6098786448427224E+09 6.2056407197471702E+08 1.7451152098515370E+27 1.7864049949914621E+18 8.7263474758255544E-01 0.0000000000000000E+00 1.3738101387657567E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0603131660666744E-12 4.9696085620158176E-01 0.0000000000000000E+00 4.9800512767121713E-01 5.0143470212204357E-03 1.9666291341993131E-05 2.8095709948366631E-09 7.6731227721550089E-16 1.2313828553315991E-23 3.8822387454350473E-33 2.1580066226928603E-44 1.2590989396244887E-57 4.1477698158682653E-72 0.0000000000000000E+00 6.8095756578387361E-90 --- ---
- 9: 2.6199836119821814E+30 6.2043999919881672E+06 6.8467604763126433E+00 2.6048731602821755E+09 6.1985074737197852E+08 1.7406312117236775E+27 1.7851217233626289E+18 8.7266671423919584E-01 0.0000000000000000E+00 1.3738099946766615E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0531629097534666E-12 4.9696103952706916E-01 0.0000000000000000E+00 4.9800524859576983E-01 5.0140442161060294E-03 1.9664847002506283E-05 2.8089919570197571E-09 7.6708725011564426E-16 1.2308414071813132E-23 3.8798689581540989E-33 2.1561206750572261E-44 1.2575150581496363E-57 4.1410274015471158E-72 0.0000000000000000E+00 6.7963239397714427E-90 --- ---
- 10: 3.1304576633028770E+30 6.5863214199832808E+06 7.2680884523345259E+00 2.5997443508872347E+09 6.1911919034092629E+08 1.7360397551590964E+27 1.7838051448007964E+18 8.7269954156656138E-01 0.0000000000000000E+00 1.3738098423826699E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0455351961846973E-12 4.9696123329207226E-01 0.0000000000000000E+00 4.9800537640404224E-01 5.0137241719219895E-03 1.9663318528268829E-05 2.8083823557668812E-09 7.6685048497444055E-16 1.2302728817303539E-23 3.8773860509709731E-33 2.1541514948527139E-44 1.2558689643562561E-57 4.1340495787305189E-72 0.0000000000000000E+00 6.7826559532129029E-90 --- ---
- 11: 3.6825249259031809E+30 6.9555725852980549E+06 7.6754143842884757E+00 2.5945007852521968E+09 6.1837058717043614E+08 1.7313487279661635E+27 1.7824573342322330E+18 8.7273318159676816E-01 0.0000000000000000E+00 1.3738096823977907E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0374463337538703E-12 4.9696143684266314E-01 0.0000000000000000E+00 4.9800551066439880E-01 5.0133879693116789E-03 1.9661710837021844E-05 2.8077445287749072E-09 7.6660289976089344E-16 1.2296796023513575E-23 3.8748006618488154E-33 2.1521080946275983E-44 1.2541687394352449E-57 4.1268719987874133E-72 0.0000000000000000E+00 6.7686426870890365E-90 --- ---
- 12: 4.2745430717472685E+30 7.3129897723894808E+06 8.0696617735884217E+00 2.5891573976009822E+09 6.1760703646588480E+08 1.7265716913770020E+27 1.7810820143346312E+18 8.7276754490956576E-01 0.0000000000000000E+00 1.3738095154375916E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0289235212461227E-12 4.9696164926846365E-01 0.0000000000000000E+00 4.9800565077607789E-01 5.0130371124474955E-03 1.9660030892987670E-05 2.8070815851419853E-09 7.6634570892432564E-16 1.2290645845469396E-23 3.8721263516752675E-33 2.1500016751112023E-44 1.2524241366914656E-57 4.1195367515347023E-72 0.0000000000000000E+00 6.7543666984141292E-90 --- ---
- 13: 4.9040548040414248E+30 7.6589093041779017E+06 8.4512026695995370E+00 2.5837341042075725E+09 6.1683135578828120E+08 1.7217266230979776E+27 1.7796842107339935E+18 8.7280250903706713E-01 0.0000000000000000E+00 1.3738093423946497E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0200041468704009E-12 4.9696186943387610E-01 0.0000000000000000E+00 4.9800579598980860E-01 5.0126734774162910E-03 1.9658287474236717E-05 2.8063972907070970E-09 7.6608037820666322E-16 1.2284314203178154E-23 3.8693790693768051E-33 2.1478451657055387E-44 1.2506461632847158E-57 4.1120905018255531E-72 0.0000000000000000E+00 6.7399183808311263E-90 --- ---
- 14: 5.5677969247037119E+30 7.9933384883839739E+06 8.8200463423214774E+00 2.5782547400988431E+09 6.1604693304540312E+08 1.7168349507082851E+27 1.7782699874457377E+18 8.7283792488325018E-01 0.0000000000000000E+00 1.3738091643134073E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0107350044162818E-12 4.9696209601007557E-01 0.0000000000000000E+00 4.9800594542892812E-01 5.0122992593497808E-03 1.9656490932380092E-05 2.8056959536992624E-09 7.6580857985047849E-16 1.2277841650842347E-23 3.8665766365228666E-33 2.1456527914153215E-44 1.2488466975975790E-57 4.1045828341679093E-72 0.0000000000000000E+00 6.7253927320837306E-90 --- ---
- 15: 6.2617378337997012E+30 8.3160708624541750E+06 9.1759664665280329E+00 2.5727461503645935E+09 6.1525759914548361E+08 1.7119207268721032E+27 1.7768462201425889E+18 8.7287362222574727E-01 0.0000000000000000E+00 1.3738089823627693E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0011713214550187E-12 4.9696232750986935E-01 0.0000000000000000E+00 4.9800609811238772E-01 5.0119169148244661E-03 1.9654652927432571E-05 2.8049823046650715E-09 7.6553214586104093E-16 1.2271272217268811E-23 3.8637382281967870E-33 2.1434396481401061E-44 1.2470381267800580E-57 4.0970647335680865E-72 0.0000000000000000E+00 6.7108864623493128E-90 --- ---
- 16: 6.9811435023736388E+30 8.6267677704250254E+06 9.5185911352092010E+00 2.5672373566210032E+09 6.1446751060123253E+08 1.7070098753787488E+27 1.7754203867586348E+18 8.7290941481986706E-01 0.0000000000000000E+00 1.3738087978065099E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9913755793744893E-12 4.9696256232534930E-01 0.0000000000000000E+00 4.9800625297959689E-01 5.0115290996556499E-03 1.9652786137878506E-05 2.8042613714513621E-09 7.6525301961220338E-16 1.2264652225881834E-23 3.8608838540552393E-33 2.1412212894525975E-44 1.2452330063733681E-57 4.0895872032996831E-72 0.0000000000000000E+00 6.6964954273309935E-90 --- ---
- 17: 7.7206704983561684E+30 8.9250184814981632E+06 9.8474691772763929E+00 2.5617587626731563E+09 6.1368103694797730E+08 1.7021294760471829E+27 1.7740003660572314E+18 8.7294510534651926E-01 0.0000000000000000E+00 1.3738086119718144E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9814161215847346E-12 4.9696279876791294E-01 0.0000000000000000E+00 4.9800640891682674E-01 5.0111386027841360E-03 1.9650903948810224E-05 2.8035383509502327E-09 7.6497320643175099E-16 1.2258029110157488E-23 3.8580338463015532E-33 2.1390133296912856E-44 1.2434437448168360E-57 4.0822000228675952E-72 0.0000000000000000E+00 6.6823123750117028E-90 --- ---
- 18: 8.4744831964120764E+30 9.2103859051398840E+06 1.0162120567451959E+01 2.5563413868601093E+09 6.1290265118090105E+08 1.6973070774419289E+27 1.7725942408443282E+18 8.7298049029282665E-01 0.0000000000000000E+00 1.3738084262168629E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9713655816287870E-12 4.9696303510950951E-01 0.0000000000000000E+00 4.9800656478441607E-01 5.0107482781499126E-03 1.9649020126916289E-05 2.8028184813216773E-09 7.6469472456563627E-16 1.2251450257366774E-23 3.8552083681978827E-33 2.1368310730199470E-44 1.2416823190746644E-57 4.0749506628092482E-72 0.0000000000000000E+00 6.6684250214434310E-90 --- ---
- 19: 9.2363909657969134E+30 9.4824421144839823E+06 1.0462075577622807E+01 2.5510161217167950E+09 6.1213682331581128E+08 1.6925700379644354E+27 1.7712101059713669E+18 8.7301536476428299E-01 0.0000000000000000E+00 1.3738082418985201E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9612991801013353E-12 4.9696326962374837E-01 0.0000000000000000E+00 4.9800671944388308E-01 5.0103609767996717E-03 1.9647148493019008E-05 2.8021069187868709E-09 7.6441955805554571E-16 1.2244961915510070E-23 3.8524269571127970E-33 2.1346891778458888E-44 1.2399600269556920E-57 4.0678833697848234E-72 0.0000000000000000E+00 6.6549144661457721E-90 --- ---
- 20: 9.9999999999996709E+30 9.7407962575145904E+06 1.0746905519115565E+01 2.5458130289649572E+09 6.1138791826737702E+08 1.6879449022904994E+27 1.7698558832783711E+18 8.7304952717563944E-01 0.0000000000000000E+00 1.3738080603410479E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9512929401140839E-12 4.9696350062570710E-01 0.0000000000000000E+00 4.9800687178417452E-01 5.0099794811492562E-03 1.9645302601528910E-05 2.8014086222136898E-09 7.6414961272135346E-16 1.2238608189160332E-23 3.8497081117764019E-33 2.1326013622361922E-44 1.2382872783987768E-57 4.0610384221154387E-72 0.0000000000000000E+00 6.6418539344172500E-90 --- ---
- 21: 1.0758873610036410E+31 9.9851164689896442E+06 1.1016246858192067E+01 2.5407606816886115E+09 6.1066009982076001E+08 1.6834568233558619E+27 1.7685391467349496E+18 8.7308278373514714E-01 0.0000000000000000E+00 1.3738078828069220E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9414218893160121E-12 4.9696372650906351E-01 0.0000000000000000E+00 4.9800702074614650E-01 5.0096064436745327E-03 1.9643495438114540E-05 2.8007282491314024E-09 7.6388667660075209E-16 1.2232430152923202E-23 3.8470689344510824E-33 2.1305801565378448E-44 1.2366734283862112E-57 4.0544515584857670E-72 0.0000000000000000E+00 6.6293078415300858E-90 --- ---
- 22: 1.1525759183621215E+31 1.0220882509282932E+07 1.1276142371346618E+01 2.5358238597635822E+09 6.0994834268667495E+08 1.6790742798836187E+27 1.7672508483779464E+18 8.7311536030654990E-01 0.0000000000000000E+00 1.3738077082857274E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9316357977101017E-12 4.9696394855937487E-01 0.0000000000000000E+00 4.9800716717777888E-01 5.0092397409667467E-03 1.9641716878469121E-05 2.8000617212861874E-09 7.6362916188801157E-16 1.2226389476049459E-23 3.8444925801107270E-33 2.1286120667852898E-44 1.2351070413374584E-57 4.0480737266094384E-72 0.0000000000000000E+00 6.6171793170026873E-90 --- ---
- 23: 1.2313811497487103E+31 1.0452769122143012E+07 1.1531746078739451E+01 2.5309111483029213E+09 6.0923949219064009E+08 1.6747160014011120E+27 1.7659671980172431E+18 8.7314785724907040E-01 0.0000000000000000E+00 1.3738075337014269E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9217645403966262E-12 4.9696417069039323E-01 0.0000000000000000E+00 4.9800731366009238E-01 5.0088729095433184E-03 1.9639935644333420E-05 2.7993971893186374E-09 7.6337248279198578E-16 1.2220378034939630E-23 3.8419326658796697E-33 2.1266613161855038E-44 1.2335592432360899E-57 4.0417858470373635E-72 0.0000000000000000E+00 6.6052396639154597E-90 --- ---
- 24: 1.3137275361782613E+31 1.0685008758771149E+07 1.1787723298271841E+01 2.5259351440570264E+09 6.0852093040311766E+08 1.6703044868775219E+27 1.7646653327958390E+18 8.7318085420381775E-01 0.0000000000000000E+00 1.3738073560407319E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9116357750950279E-12 4.9696439673606163E-01 0.0000000000000000E+00 4.9800746272129842E-01 5.0084996180433921E-03 1.9638120954008586E-05 2.7987232017125375E-09 7.6311221205947185E-16 1.2214292113547969E-23 3.8393449755279669E-33 2.1246941305142976E-44 1.2320031075635169E-57 4.0354778624825893E-72 0.0000000000000000E+00 6.5932787635438614E-90 --- ---
- 25: 1.4012262626283836E+31 1.0921665557921387E+07 1.2048552701717528E+01 2.5208073402275629E+09 6.0777983857381439E+08 1.6657614652723174E+27 1.7633219809458278E+18 8.7321494396480115E-01 0.0000000000000000E+00 1.3738071721913718E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.9010656724577058E-12 4.9696463065629221E-01 0.0000000000000000E+00 4.9800761697249646E-01 5.0081133274034097E-03 1.9636240871076841E-05 2.7980280863241968E-09 7.6284384120409696E-16 1.2208026756575542E-23 3.8366850352643243E-33 2.1226768636401776E-44 1.2304121320511372E-57 4.0290423906096587E-72 0.0000000000000000E+00 6.5810927672487866E-90 --- ---
- 26: 1.4957694626029211E+31 1.1166863152942896E+07 1.2318777327883366E+01 2.5154332798899078E+09 6.0700249288453829E+08 1.6610036215656713E+27 1.7619121800162522E+18 8.7325076533354284E-01 0.0000000000000000E+00 1.3738069787808771E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.8898489421364087E-12 4.9696487674209278E-01 0.0000000000000000E+00 4.9800777924291878E-01 5.0077069521509369E-03 1.9634260640468229E-05 2.7972993530512017E-09 7.6256254938841157E-16 1.2201470406946195E-23 3.8339058439922277E-33 2.1205742810674786E-44 1.2287588814754896E-57 4.0223691759398617E-72 0.0000000000000000E+00 6.5684734695590830E-90 --- ---
- 27: 1.5996501841471306E+31 1.1424993597828886E+07 1.2603234631628716E+01 2.5097074804259510E+09 6.0617352114718521E+08 1.6559381499142370E+27 1.7604079176167444E+18 8.7328903835582028E-01 0.0000000000000000E+00 1.3738067720017689E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.8777472402510378E-12 4.9696513983799362E-01 0.0000000000000000E+00 4.9800795272655840E-01 5.0072724931737008E-03 1.9632140865555200E-05 2.7965230654386713E-09 7.6226296064356125E-16 1.2194499353717972E-23 3.8309555555004579E-33 2.1183478454811482E-44 1.2270136691166518E-57 4.0153398018416284E-72 0.0000000000000000E+00 6.5551983007284262E-90 --- ---
- 28: 1.7157205765521055E+31 1.1700926818906905E+07 1.2907286928037458E+01 2.5035076712810884E+09 6.0527505267271566E+08 1.6504577367749998E+27 1.7587765697479485E+18 8.7333060524107642E-01 0.0000000000000000E+00 1.3738065474093046E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.8644749057646602E-12 4.9696542559939888E-01 0.0000000000000000E+00 4.9800814115179493E-01 5.0068006128716524E-03 1.9629835379037071E-05 2.7956831335133224E-09 7.6193887088922533E-16 1.2186971572152365E-23 3.8277749391105548E-33 2.1159538768011542E-44 1.2251431783274954E-57 4.0078222587294242E-72 0.0000000000000000E+00 6.5410201574996209E-90 --- ---
- 29: 1.8476059264908175E+31 1.2000236001008619E+07 1.3237069151481519E+01 2.4966878592779088E+09 6.0428568799971592E+08 1.6444345594127063E+27 1.7569789999968650E+18 8.7337648067419282E-01 0.0000000000000000E+00 1.3738062996767555E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.8496807044433271E-12 4.9696574080397732E-01 0.0000000000000000E+00 4.9800834898661006E-01 5.0062801211506504E-03 1.9627288643886845E-05 2.7947604798338724E-09 7.6158292609099513E-16 1.2178719549833321E-23 3.8242944558516685E-33 2.1133414734208525E-44 1.2231089422954313E-57 3.9996650450159083E-72 0.0000000000000000E+00 6.5256564583509380E-90 --- ---
- 30: 1.9999999999999630E+31 1.2329452470956011E+07 1.3599768769823056E+01 2.4890696510369782E+09 6.0317920075379503E+08 1.6377128211369062E+27 1.7549671541002478E+18 8.7342791612617621E-01 0.0000000000000000E+00 1.3738060222910763E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.8329238423885835E-12 4.9696609373890832E-01 0.0000000000000000E+00 4.9800858169375772E-01 5.0056973362685693E-03 1.9624432492504375E-05 2.7937320282047122E-09 7.6118623183642434E-16 1.2169541686775348E-23 3.8204307908609919E-33 2.1104500908632241E-44 1.2208656130697251E-57 3.9906905399867217E-72 0.0000000000000000E+00 6.5087769375481185E-90 --- ---
- 31: 2.1790790876294910E+31 1.2696363050641827E+07 1.4003951976422506E+01 2.4804311206237745E+09 6.0192286004243255E+08 1.6300992365553876E+27 1.7526809368610537E+18 8.7348648424338282E-01 0.0000000000000000E+00 1.3738057071687731E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.8136418841794385E-12 4.9696649468967802E-01 0.0000000000000000E+00 4.9800884605279977E-01 5.0050352781597683E-03 1.9621181971485027E-05 2.7925694606848659E-09 7.6073787295778900E-16 1.2159191843517218E-23 3.8160826843019767E-33 2.1072066833234680E-44 1.2183589639814002E-57 3.9806874478142068E-72 0.0000000000000000E+00 6.4899898102619015E-90 --- ---
- 32: 2.3876492120280019E+31 1.3100136267390139E+07 1.4448686932777068E+01 2.4706299719529266E+09 6.0049529454451132E+08 1.6214718244683059E+27 1.7500806592944425E+18 8.7355325144657048E-01 0.0000000000000000E+00 1.3738053492136105E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.7914205118007764E-12 4.9696695014105075E-01 0.0000000000000000E+00 4.9800914633638099E-01 5.0042832443553831E-03 1.9617482157542105E-05 2.7912561964945994E-09 7.6023145841571670E-16 1.2147530972799222E-23 3.8111948074786902E-33 2.1035735394113343E-44 1.2155629976424747E-57 3.9695590457626999E-72 0.0000000000000000E+00 6.4691202443527224E-90 --- ---
- 33: 2.6284136724418553E+31 1.3539159681880834E+07 1.4932179808661104E+01 2.4596313676227870E+09 5.9889060003246772E+08 1.6118041261423293E+27 1.7471545773962378E+18 8.7362858089621587E-01 0.0000000000000000E+00 1.3738049474006502E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.7660727485146062E-12 4.9696746139771009E-01 0.0000000000000000E+00 4.9800948340118206E-01 5.0034390868777803E-03 1.9613319665240604E-05 2.7897910324767396E-09 7.5966651641646337E-16 1.2134557770813525E-23 3.8057700112044046E-33 2.0995566650819108E-44 1.2124856917309980E-57 3.9573441320094156E-72 0.0000000000000000E+00 6.4462474895058971E-90 --- ---
- 34: 2.9038797845213166E+31 1.4011130304633314E+07 1.5451874956550288E+01 2.4474200131921520E+09 5.9710558873421407E+08 1.6010875372337645E+27 1.7438957252836851E+18 8.7371272381557985E-01 0.0000000000000000E+00 1.3738045016221461E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.7374515265454208E-12 4.9696802859740474E-01 0.0000000000000000E+00 4.9800985733409525E-01 5.0025025853159474E-03 1.9608690262478546E-05 2.7881763303350886E-09 7.5904393375857096E-16 1.2120302627077580E-23 3.7998244601763166E-33 2.0951719438966077E-44 1.2091424908381048E-57 3.9441103433624334E-72 0.0000000000000000E+00 6.4215035955964579E-90 --- ---
- 35: 3.2162587678984315E+31 1.4513168023087824E+07 1.6004580536174775E+01 2.4340012979947305E+09 5.9513997484128082E+08 1.5893322074188608E+27 1.7403022717229970E+18 8.7380580925543916E-01 0.0000000000000000E+00 1.3738040127504400E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.7054586255071236E-12 4.9696865063089468E-01 0.0000000000000000E+00 4.9801026739961152E-01 5.0014755787060033E-03 1.9603599656595706E-05 2.7864180926818117E-09 7.5836598227951660E-16 1.2104827585414735E-23 3.7933873662496452E-33 2.0904446452642979E-44 1.2055556634918612E-57 3.9299510202118081E-72 0.0000000000000000E+00 6.3950670375227928E-90 --- ---
- 36: 3.5673624784155728E+31 1.5041937279142816E+07 1.6586603287915224E+01 2.4194017661453519E+09 5.9299647203577387E+08 1.5765673001634111E+27 1.7363777286922726E+18 8.7390783689637230E-01 0.0000000000000000E+00 1.3738034826525292E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.6700525894270846E-12 4.9696932512337788E-01 0.0000000000000000E+00 4.9801071202779490E-01 5.0003619958014535E-03 1.9598063822309157E-05 2.7845258338045799E-09 7.5763626838741724E-16 1.2088224476376325E-23 3.7864999524340157E-33 2.0854083653670801E-44 1.2017532460144894E-57 3.9149805797128796E-72 0.0000000000000000E+00 6.3671537627698251E-90 --- ---
- 37: 3.9585013844433089E+31 1.5593765398859266E+07 1.7193879639610611E+01 2.4036689752759976E+09 5.9068081069940794E+08 1.5628406676609305E+27 1.7321310255879493E+18 8.7401867255041266E-01 0.0000000000000000E+00 1.3738029141551474E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.6312551657467782E-12 4.9697004847888238E-01 0.0000000000000000E+00 4.9801118884380602E-01 4.9991677813138969E-03 1.9592108846510020E-05 2.7825122587844638E-09 7.5685961154907246E-16 1.2070611436239888E-23 3.7792137696253919E-33 2.0801035285951678E-44 1.1977677040955099E-57 3.8993289771628946E-72 0.0000000000000000E+00 6.3380067792633718E-90 --- ---
- 38: 4.3903886984728140E+31 1.6164750113713734E+07 1.7822094895448807E+01 2.3868708068630533E+09 5.8820168279333901E+08 1.5482180049716492E+27 1.7275764624537111E+18 8.7413804608271772E-01 0.0000000000000000E+00 1.3738023109634812E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.5891558367112201E-12 4.9697081598364368E-01 0.0000000000000000E+00 4.9801169473632906E-01 4.9979007247335609E-03 1.9585770304134924E-05 2.7803927832469016E-09 7.5604186429201905E-16 1.2052128181806926E-23 3.7715885486008712E-33 2.0745756159754136E-44 1.1936344628629673E-57 3.8831358719286133E-72 0.0000000000000000E+00 6.3078854173280834E-90 --- ---
- 39: 4.8630558330374140E+31 1.6750852735022031E+07 1.8466786579764864E+01 2.3690942870776439E+09 5.8557062112554431E+08 1.5327815461634159E+27 1.7227335524821875E+18 8.7426555160071040E-01 0.0000000000000000E+00 1.3738016775405407E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.5439140750735953E-12 4.9697162195954592E-01 0.0000000000000000E+00 4.9801222595899453E-01 4.9965702065066057E-03 1.9579092216534224E-05 2.7781849398942504E-09 7.5518969102926006E-16 1.2032930505916558E-23 3.7636898007894418E-33 2.0688732982581991E-44 1.1893904511732808E-57 3.8665450520787158E-72 0.0000000000000000E+00 6.2770552432143956E-90 --- ---
- 40: 5.3757843040777123E+31 1.7347976467814416E+07 1.9123431346661800E+01 2.3504439693609910E+09 5.8280181809819245E+08 1.5166283610897120E+27 1.7176267603142525E+18 8.7440064990538791E-01 0.0000000000000000E+00 1.3738010189570165E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.4957590421006029E-12 4.9697245995512351E-01 0.0000000000000000E+00 4.9801277825652740E-01 4.9951868822652136E-03 1.9572125672824284E-05 2.7759077246333694E-09 7.5431032505342853E-16 1.2013184481160794E-23 3.7555863789054788E-33 2.0630466351078099E-44 1.1850727793746754E-57 3.8496995359747751E-72 0.0000000000000000E+00 6.2457793280503672E-90 --- ---
- 41: 5.9270588244899706E+31 1.7952031276405588E+07 1.9787516987499881E+01 2.3310399250564766E+09 5.7991188789664078E+08 1.4998683091307458E+27 1.7122851399421233E+18 8.7454267331038205E-01 0.0000000000000000E+00 1.3738003407231599E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.4449865743715472E-12 4.9697332295944574E-01 0.0000000000000000E+00 4.9801334700592276E-01 4.9937623293827577E-03 1.9564927215363186E-05 2.7735809350659693E-09 7.5341132270451782E-16 1.1993060821546955E-23 3.7473481807442003E-33 2.0571454673988876E-44 1.1807176320117494E-57 3.8327376049904927E-72 0.0000000000000000E+00 6.2143112707924210E-90 --- ---
- 42: 6.5145456094108000E+31 1.8558987656311277E+07 2.0454602109884398E+01 2.3110153887935238E+09 5.7691957584281242E+08 1.4826217076391268E+27 1.7067418750789420E+18 8.7469083299564898E-01 0.0000000000000000E+00 1.3737996486144977E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3919534583853888E-12 4.9697420362385281E-01 0.0000000000000000E+00 4.9801392736272071E-01 4.9923086807034563E-03 1.9557557099048702E-05 2.7712245474447101E-09 7.5250033111136582E-16 1.1972729762620161E-23 3.7390441324043576E-33 2.0512180841759025E-44 1.1763594152830521E-57 3.8157898585995392E-72 0.0000000000000000E+00 6.1828900859691231E-90 --- ---
- 43: 7.1350988737330512E+31 1.9164921880954050E+07 2.1120366298569699E+01 2.2905141107093859E+09 5.7384541929472542E+08 1.4650167775844564E+27 1.7010337257840791E+18 8.7484422906031456E-01 0.0000000000000000E+00 1.3737989485022300E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3370691625903280E-12 4.9697509447775179E-01 0.0000000000000000E+00 4.9801451440328309E-01 4.9908382682309392E-03 1.9550077531420023E-05 2.7688581669817708E-09 7.5158488183861190E-16 1.1952356703371867E-23 3.7307405322737296E-33 2.0453101992871203E-44 1.1720301615809933E-57 3.7989772486043305E-72 0.0000000000000000E+00 6.1517368394991495E-90 --- ---
- 44: 7.7847971902777501E+31 1.9766055046513844E+07 2.1780653299079408E+01 2.2696874763059478E+09 5.7071136583862925E+08 1.4471869353411932E+27 1.6952003876069222E+18 8.7500186338137043E-01 0.0000000000000000E+00 1.3737982461972297E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.2807853727007664E-12 4.9697598812711818E-01 0.0000000000000000E+00 4.9801510325558684E-01 4.9893632955175082E-03 1.9542550988567922E-05 2.7665005731046497E-09 7.5067221811251817E-16 1.1932098731548639E-23 3.7224997844774176E-33 2.0394642327900817E-44 1.1677591652882632E-57 3.7824099573646865E-72 0.0000000000000000E+00 6.1210527674483170E-90 --- ---
- 45: 8.4590098686623695E+31 2.0358787755603854E+07 2.2431509239196501E+01 2.2486914645236111E+09 5.6754035627847302E+08 1.4292680057091321E+27 1.6892837730170342E+18 8.7516265528339499E-01 0.0000000000000000E+00 1.3737975473138400E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.2235838188709877E-12 4.9697687742781477E-01 0.0000000000000000E+00 4.9801568921334527E-01 4.9878955517589398E-03 1.9535038680612998E-05 2.7641693673747627E-09 7.4976915849526785E-16 1.1912102039253439E-23 3.7143795044833658E-33 2.0337188613817829E-44 1.1635728056522204E-57 3.7661869317907854E-72 0.0000000000000000E+00 6.0910185315502691E-90 --- ---
- 46: 9.1524919059324317E+31 2.0939731715360809E+07 2.3069217280163720E+01 2.2276835233559413E+09 5.6435588177123129E+08 1.4113954353410165E+27 1.6833272288731267E+18 8.7532545988677024E-01 0.0000000000000000E+00 1.3737968571571271E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.1659630168209232E-12 4.9697775562908086E-01 0.0000000000000000E+00 4.9801626783041025E-01 4.9864461752352485E-03 1.9527599219290375E-05 2.7618807211161904E-09 7.4888199626209766E-16 1.1892500157046885E-23 3.7064319509942361E-33 2.0281087866725794E-44 1.1594945070692851E-57 3.7503958786151847E-72 0.0000000000000000E+00 6.0617942645747759E-90 --- ---
- 47: 9.8595044599930061E+31 2.1505738974040221E+07 2.3690329497256094E+01 2.2068194483685617E+09 5.6118152613402104E+08 1.3937015865616156E+27 1.6773747076355935E+18 8.7548908884780574E-01 0.0000000000000000E+00 1.3737961806345211E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.1084245982339882E-12 4.9697861648599023E-01 0.0000000000000000E+00 4.9801683499468474E-01 4.9850254680449202E-03 1.9520287514685277E-05 2.7596492110954672E-09 7.4801643072575679E-16 1.1873412876785437E-23 3.6987037195803368E-33 2.0226646631337293E-44 1.1555447879463251E-57 3.7351135398654264E-72 0.0000000000000000E+00 6.0335200880715795E-90 --- ---
- 48: 1.0573956320148394E+32 2.2053929034890752E+07 2.4291696255829681E+01 2.1862503517803936E+09 5.5804050562618744E+08 1.3763131885344260E+27 1.6714699135174751E+18 8.7565233304430257E-01 0.0000000000000000E+00 1.3737955221908654E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0514599211618393E-12 4.9697945434213642E-01 0.0000000000000000E+00 4.9801738698239501E-01 4.9836427600134306E-03 1.9513153908175417E-05 2.7574877274281335E-09 7.4717752530205217E-16 1.1854945714275459E-23 3.6912356308966915E-33 2.0174131319822573E-44 1.1517413576300247E-57 3.7204061049776885E-72 0.0000000000000000E+00 6.0063168544214703E-90 --- ---
- 49: 1.1289560604909510E+32 2.2581713691725142E+07 2.4870492924586689E+01 2.1661198078509035E+09 5.5495521926679993E+08 1.3593490158877171E+27 1.6656554474522324E+18 8.7581398660885401E-01 0.0000000000000000E+00 1.3737948857644406E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.9955375969374244E-12 4.9698026418561991E-01 0.0000000000000000E+00 4.9801792049476917E-01 4.9823063166685175E-03 1.9506243531736666E-05 2.7554074365730220E-09 7.4636968657610868E-16 1.1837189765070436E-23 3.6840627517904134E-33 2.0123769164338253E-44 1.1480992312695529E-57 3.7063296574718457E-72 0.0000000000000000E+00 5.9802869390309382E-90 --- ---
- 50: 1.1999999999999980E+32 2.3086819136037227E+07 2.5424243455780740E+01 2.1465612542510900E+09 5.5194682289420664E+08 1.3429178547546855E+27 1.6599719763802752E+18 8.7597287158062465E-01 0.0000000000000000E+00 1.3737942747609141E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.9410924754544351E-12 4.9698104168223078E-01 0.0000000000000000E+00 4.9801843267970464E-01 4.9810232848243822E-03 1.9499595873550186E-05 2.7534177838800489E-09 7.4559665908904575E-16 1.1820221829636653E-23 3.6772145003270174E-33 2.0075749465486591E-44 1.1446308439777560E-57 3.6929305973113950E-72 0.0000000000000000E+00 5.9555149844250245E-90 --- ---
- 51: 1.2699093329921292E+32 2.3567304691261414E+07 2.5950840153708192E+01 2.1276957193268297E+09 5.4903483967417216E+08 1.3271168035319405E+27 1.6544574527524137E+18 8.7612786235131879E-01 0.0000000000000000E+00 1.3737936920419569E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.8885164912820322E-12 4.9698178318996367E-01 0.0000000000000000E+00 4.9801892114116009E-01 4.9797996689297718E-03 1.9493244523719840E-05 2.7515265229532090E-09 7.4486153141574378E-16 1.1804104712797312E-23 3.6707147995683933E-33 2.0030224938572486E-44 1.1413461552197056E-57 3.6802460144203700E-72 0.0000000000000000E+00 5.9320685575240925E-90 --- ---
- 52: 1.3389094018350411E+32 2.4026918777306151E+07 2.6454410139084313E+01 2.1095233176394558E+09 5.4622027769201362E+08 1.3119410360509305E+27 1.6491149774296604E+18 8.7627879920828666E-01 0.0000000000000000E+00 1.3737931366440357E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.8378522752358296E-12 4.9698248993438554E-01 0.0000000000000000E+00 4.9801938668942353E-01 4.9786334413678655E-03 1.9487181248401695E-05 2.7497291430160139E-09 7.4416262080102866E-16 1.1788797191056181E-23 3.6645458099329280E-33 1.9987058018203962E-44 1.1382343561968607E-57 3.6682330376989888E-72 0.0000000000000000E+00 5.9098675543599770E-90 --- ---
- 53: 1.4072171717118605E+32 2.4468846153731428E+07 2.6938458292511694E+01 2.0919421902317359E+09 5.4348825587376344E+08 1.2973010664269471E+27 1.6439173817038108E+18 8.7642638408346751E-01 0.0000000000000000E+00 1.3737926046451239E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.7888504680318671E-12 4.9698316690583932E-01 0.0000000000000000E+00 4.9801983261418076E-01 4.9775163630817205E-03 1.9481365089889939E-05 2.7480118497990295E-09 7.4349462148091905E-16 1.1774179651546177E-23 3.6586583832026343E-33 1.9945895103613590E-44 1.1352692868932773E-57 3.6567898281326626E-72 0.0000000000000000E+00 5.8887231008178808E-90 --- ---
- 54: 1.4750432780659248E+32 2.4895832760556966E+07 2.7406004979774718E+01 2.0748623840656188E+09 5.4082553093418908E+08 1.2831183522906475E+27 1.6388403501042432E+18 8.7657125402345271E-01 0.0000000000000000E+00 1.3737920926535464E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.7412874616384093E-12 4.9698381841989459E-01 0.0000000000000000E+00 4.9802026176008080E-01 4.9764413094543604E-03 1.9475760458610043E-05 2.7463628325074119E-09 7.4285298605954214E-16 1.1760149946955217E-23 3.6530106547190320E-33 1.9906436134485281E-44 1.1324288303578510E-57 3.6458303964415704E-72 0.0000000000000000E+00 5.8684757984664670E-90 --- ---
- 55: 1.5425939774471797E+32 2.5310279397997320E+07 2.7859689376183066E+01 2.0582034800053203E+09 5.3822016444889843E+08 1.2693231406417898E+27 1.6338618289723402E+18 8.7671399545641704E-01 0.0000000000000000E+00 1.3737915977026857E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.6949610796184515E-12 4.9698444825131005E-01 0.0000000000000000E+00 4.9802067661510935E-01 4.9754020490220133E-03 1.9470336084220026E-05 2.7447718547112167E-09 7.4223376945687089E-16 1.1746619750866494E-23 3.6475665076360640E-33 1.9868423123557276E-44 1.1296940331516664E-57 3.6352811362073737E-72 0.0000000000000000E+00 5.8489892662315134E-90 --- ---
- 56: 1.6100730319096502E+32 2.5714313498339538E+07 2.8301848600307530E+01 2.0418927225048480E+09 5.3566125875325412E+08 1.2558527768638181E+27 1.6289615550708093E+18 8.7685515571087080E-01 0.0000000000000000E+00 1.3737911171686983E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.6496870355654118E-12 4.9698505973872265E-01 0.0000000000000000E+00 4.9802107937964474E-01 4.9743930705544058E-03 1.9465064191150704E-05 2.7432299390619904E-09 7.4163350858310656E-16 1.1733511762161338E-23 3.6422943996463085E-33 1.9831631448212392E-44 1.1270484414825075E-57 3.6250782135182939E-72 0.0000000000000000E+00 5.8301452822164836E-90 --- ---
- 57: 1.6776835556955623E+32 2.6109845193762172E+07 2.8734579506507611E+01 2.0258635164368234E+09 5.3313874302508688E+08 1.2426503534005818E+27 1.6241206713812713E+18 8.7699525256280531E-01 0.0000000000000000E+00 1.3737906487051367E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.6052959839109236E-12 4.9698565586783083E-01 0.0000000000000000E+00 4.9802147202132285E-01 4.9734094456649162E-03 1.9459919839652741E-05 2.7417291201478217E-09 7.4104912795234521E-16 1.1720757523035997E-23 3.6371664506626550E-33 1.9795863116821355E-44 1.1244775907690618E-57 3.6151655642468894E-72 0.0000000000000000E+00 5.8118400594873412E-90 --- ---
- 58: 1.7456298521421902E+32 2.6498611943291198E+07 2.9159787839292878E+01 2.0100541966634853E+09 5.3064319644531661E+08 1.2296636115606800E+27 1.6193214069658493E+18 8.7713478235853681E-01 0.0000000000000000E+00 1.3737901901903045E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.5616310429706291E-12 4.9698623933837383E-01 0.0000000000000000E+00 4.9802185631921131E-01 4.9724467181914631E-03 1.9454880392175869E-05 2.7402622480325618E-09 7.4047786459408013E-16 1.1708295691279420E-23 3.6321577229361423E-33 1.9760941482815934E-44 1.1219686070087868E-57 3.6054933330082620E-72 0.0000000000000000E+00 5.7939813453564035E-90 --- ---
- 59: 1.8141192685407427E+32 2.6882214715270709E+07 2.9579228055029830E+01 1.9944070026037996E+09 5.2816569899883705E+08 1.2168440344826943E+27 1.6145468041889856E+18 8.7727422711351510E-01 0.0000000000000000E+00 1.3737897396843007E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.5185456971678464E-12 4.9698681261878719E-01 0.0000000000000000E+00 4.9802223389985234E-01 4.9715008139362294E-03 1.9449925075487204E-05 2.7388228299037772E-09 7.3991720747843275E-16 1.1696070652714752E-23 3.6272456447876444E-33 1.9726707033646389E-44 1.1195098907180580E-57 3.5960166376439440E-72 0.0000000000000000E+00 5.7764861271571937E-90 --- ---
- 60: 1.8833640970564785E+32 2.7262147876103647E+07 2.9994536185015146E+01 1.9788672081448488E+09 5.2569770296275210E+08 1.2041460860071824E+27 1.6097804809245760E+18 8.7741406088850671E-01 0.0000000000000000E+00 1.3737892953932590E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.4759019842965012E-12 4.9698737799170312E-01 0.0000000000000000E+00 4.9802260626726524E-01 4.9705679655294641E-03 1.9445034613938375E-05 2.7374048999105371E-09 7.3936484767499367E-16 1.1684031384697302E-23 3.6224095401426301E-33 1.9693013969288902E-44 1.1170908613288545E-57 3.5866945717396658E-72 0.0000000000000000E+00 5.7592787813403376E-90 --- ---
- 61: 1.9535835507965445E+32 2.7639824360503513E+07 3.0407257473286208E+01 1.9633823697776842E+09 5.2323091983407491E+08 1.1915265618092412E+27 1.6050064183407035E+18 8.7755475567499663E-01 0.0000000000000000E+00 1.3737888556394060E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.4335689423388443E-12 4.9698793759204790E-01 0.0000000000000000E+00 4.9802297482806590E-01 4.9696446495217312E-03 1.9440190920743384E-05 2.7360029114142460E-09 7.3881863705645614E-16 1.1672130518314592E-23 3.6176302414602903E-33 1.9659727399303353E-44 1.1147017486704453E-57 3.5774893921621307E-72 0.0000000000000000E+00 5.7422895669438373E-90 --- ---
- 62: 2.0250058457133319E+32 2.8016597300290573E+07 3.0818870089614496E+01 1.9479016646708412E+09 5.2075721865038800E+08 1.1789440273622244E+27 1.6002087669125389E+18 8.7769678698068676E-01 0.0000000000000000E+00 1.3737884188353545E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.3914212449183892E-12 4.9698849343974644E-01 0.0000000000000000E+00 4.9802334091302775E-01 4.9687275323841082E-03 1.9435376831351082E-05 2.7346116456235016E-09 7.3827655324427416E-16 1.1660323545823269E-23 3.6128897636211469E-33 1.9626720991845810E-44 1.1123334188269129E-57 3.5683658416440904E-72 0.0000000000000000E+00 5.7254533704726260E-90 --- ---
- 63: 2.0978704213002423E+32 2.8393779009510756E+07 3.1230805900447457E+01 1.9323752967185204E+09 5.1826853250052726E+08 1.1663583232230684E+27 1.5953716647498004E+18 8.7784063927205391E-01 0.0000000000000000E+00 1.3737879834617850E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.3493380051232077E-12 4.9698904746812667E-01 0.0000000000000000E+00 4.9802370579580635E-01 4.9678134236134834E-03 1.9430575870552082E-05 2.7332261331686795E-09 7.3773666948885298E-16 1.1648568142505400E-23 3.6081710257223021E-33 1.9593874976547520E-44 1.1099772268124917E-57 3.5592905766234981E-72 0.0000000000000000E+00 5.7087086467103911E-90 --- ---
- 64: 2.1724303360364681E+32 2.8772658025890525E+07 3.1644469071119328E+01 1.9167539531876664E+09 5.1575677062237072E+08 1.1537301224664501E+27 1.5904790633235668E+18 8.7798681141386059E-01 0.0000000000000000E+00 1.3737875480477834E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.3072017282253788E-12 4.9698960154893479E-01 0.0000000000000000E+00 4.9802407070942822E-01 4.9668992344344782E-03 1.9425772046226294E-05 2.7318415858101737E-09 7.3719712841716869E-16 1.1636823578016087E-23 3.6034576102892339E-33 1.9561074423104574E-44 1.1076248900927110E-57 3.5502316768672060E-72 0.0000000000000000E+00 5.6919965118195244E-90 --- ---
- 65: 2.2489548773511207E+32 2.9154514767882694E+07 3.2061253108229891E+01 1.9009882979543271E+09 5.1321373392065501E+08 1.1410205283258323E+27 1.5855145903944356E+18 8.7813582223449205E-01 0.0000000000000000E+00 1.3737871111529827E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.2648973709724379E-12 4.9699015751505793E-01 0.0000000000000000E+00 4.9802443686126729E-01 4.9659819402881021E-03 1.9420949660846123E-05 2.7304533351564814E-09 7.3665611845072543E-16 1.1625050189933088E-23 3.5987335486038751E-33 1.9528207713273901E-44 1.1052683767902919E-57 3.5411582128314806E-72 0.0000000000000000E+00 5.6752599441361088E-90 --- ---
- 66: 2.3277324306118210E+32 2.9540636267970141E+07 3.2482578475778858E+01 1.8850284828929534E+09 5.1063143780903077E+08 1.1281907025555474E+27 1.5804612112993134E+18 8.7828827580258229E-01 0.0000000000000000E+00 1.3737866568738804E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.2209096784019015E-12 4.9699073560435175E-01 0.0000000000000000E+00 4.9802481757980521E-01 4.9650281503321814E-03 1.9415933271569153E-05 2.7290108054615068E-09 7.3609393635750180E-16 1.1612819118880927E-23 3.5938267537955541E-33 1.9494077481493214E-44 1.1028218375978388E-57 3.5317397035210506E-72 0.0000000000000000E+00 5.6578894975885472E-90 --- ---
- 67: 2.4090736574335975E+32 2.9932330365827333E+07 3.2909865115192638E+01 1.8688237024277344E+09 5.0800081673673368E+08 1.1152015169291472E+27 1.5753013836750702E+18 8.7844469010762760E-01 0.0000000000000000E+00 1.3737861980440902E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.1765078487774050E-12 4.9699131948552389E-01 0.0000000000000000E+00 4.9802520210963847E-01 4.9640648094254275E-03 1.9410864673239949E-05 2.7275547186763585E-09 7.3552645857911191E-16 1.1600475738748363E-23 3.5888757859021977E-33 1.9459647518850986E-44 1.1003543685366707E-57 3.5222422411691069E-72 0.0000000000000000E+00 5.6403760999147123E-90 --- ---
- 68: 2.4933150406163306E+32 3.0330939711359646E+07 3.3344569171896453E+01 1.8523217136684444E+09 5.0531285101095176E+08 1.1020132218025124E+27 1.5700165438497784E+18 8.7860568098282465E-01 0.0000000000000000E+00 1.3737857330663630E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.1315656226714470E-12 4.9699191119113839E-01 0.0000000000000000E+00 4.9802559178951133E-01 4.9630885637835642E-03 1.9405726347420762E-05 2.7260799575689840E-09 7.3495169748942683E-16 1.1587976719706453E-23 3.5838632537393033E-33 1.9424796760618349E-44 1.0978572929498810E-57 3.5126324901696768E-72 0.0000000000000000E+00 5.6226584059869511E-90 --- ---
- 69: 2.5808228614584748E+32 3.0737855883919880E+07 3.3788197941783821E+01 1.8354683845700364E+09 5.0255807020963782E+08 1.0885851269333353E+27 1.5645870789318392E+18 8.7877190969273589E-01 0.0000000000000000E+00 1.3737852604580745E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0859705727123589E-12 4.9699251260790678E-01 0.0000000000000000E+00 4.9802598786207858E-01 4.9620963003192391E-03 1.9400502019978035E-05 2.7245817817428164E-09 7.3436781227551320E-16 1.1575281970981385E-23 3.5787730797498029E-33 1.9389413407503981E-44 1.0953226079557195E-57 3.5028797345656315E-72 0.0000000000000000E+00 5.6046799426665100E-90 --- ---
- 70: 2.6719976853101119E+32 3.1154533925828133E+07 3.4242325495541429E+01 1.8182072287950594E+09 4.9972646623266828E+08 1.0748752908283262E+27 1.5589920838488722E+18 8.7894409186413969E-01 0.0000000000000000E+00 1.3737847786390988E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0396045437073151E-12 4.9699312574662552E-01 0.0000000000000000E+00 4.9802639165168366E-01 4.9610847012672328E-03 1.9395174321166985E-05 2.7230551532252632E-09 7.3377284628308223E-16 1.1562348925318083E-23 3.5735882072143572E-33 1.9353378977723230E-44 1.0927418414870606E-57 3.4929514805090751E-72 0.0000000000000000E+00 5.5863810034934472E-90 --- ---
- 71: 2.7672794433236437E+32 3.1582507584398247E+07 3.4708608930820674E+01 1.8004789290015879E+09 4.9680739378155744E+08 1.0608402158841759E+27 1.5532091344361032E+18 8.7912300642940233E-01 0.0000000000000000E+00 1.3737842859658130E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.9923480422383785E-12 4.9699375269890661E-01 0.0000000000000000E+00 4.9802680453586584E-01 4.9600503155684036E-03 1.9389725164139112E-05 2.7214948899674169E-09 7.3316476893160840E-16 1.1549133449349373E-23 3.5682909655747913E-33 1.9316570848205050E-44 1.0901062346887851E-57 3.4828141608924940E-72 0.0000000000000000E+00 5.5676999529897126E-90 --- ---
- 72: 2.8671532128046399E+32 3.2023405566138491E+07 3.5188805637251413E+01 1.7822208435023196E+09 4.9378946478609496E+08 1.0464345475620380E+27 1.5472140376702684E+18 8.7930950595850987E-01 0.0000000000000000E+00 1.3737837807153756E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.9440799864535468E-12 4.9699439565718140E-01 0.0000000000000000E+00 4.9802722795853677E-01 4.9589895258607894E-03 1.9384135573641143E-05 2.7198955171549611E-09 7.3254145623471641E-16 1.1535589420691205E-23 3.5628629014082721E-33 1.9278861083785372E-44 1.0874066585929939E-57 3.4724328180354581E-72 0.0000000000000000E+00 5.5485726478016191E-90 --- ---
- 73: 2.9721558158067136E+32 3.2478969128185980E+07 3.5684791912412500E+01 1.7633664919909556E+09 4.9066043392317361E+08 1.0316107768488108E+27 1.5409805551727386E+18 8.7950452843047688E-01 0.0000000000000000E+00 1.3737832610690994E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.8946775877271420E-12 4.9699505693586321E-01 0.0000000000000000E+00 4.9802766344391963E-01 4.9578985135589988E-03 1.9378385504446843E-05 2.7182512670965417E-09 7.3190067037384730E-16 1.1521668284790394E-23 3.5572846017213665E-33 1.9240115216981011E-44 1.0846335275673041E-57 3.4617707748926210E-72 0.0000000000000000E+00 5.5289318381902559E-90 --- ---
- 74: 3.0828833761965824E+32 3.2951071366304226E+07 3.6198583294592012E+01 1.7438450166309175E+09 4.8740707359298670E+08 1.0163189463808209E+27 1.5344800943860429E+18 8.7970911073344105E-01 0.0000000000000000E+00 1.3737827250948127E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.8440164106825075E-12 4.9699573899379179E-01 0.0000000000000000E+00 4.9802811261133240E-01 4.9567732218195881E-03 1.9372453648349995E-05 2.7165560232284769E-09 7.3124003815062340E-16 1.1507318589026185E-23 3.5515355085901457E-33 1.9200190971772670E-44 1.0817767090884869E-57 3.4507892931960983E-72 0.0000000000000000E+00 5.5087065471954212E-90 --- ---
- 75: 3.1999999999999984E+32 3.3441738607751362E+07 3.6732357026499123E+01 1.7235806155111001E+09 4.8401503660292262E+08 1.0005063619040640E+27 1.5276813615499264E+18 8.7992440423993412E-01 0.0000000000000000E+00 1.3737821707277499E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7919706343522828E-12 4.9699644445855218E-01 0.0000000000000000E+00 4.9802857719120402E-01 4.9556093154160550E-03 1.9366317224676937E-05 2.7148032597982058E-09 7.3055702776863684E-16 1.1492485481867871E-23 3.5455937203043411E-33 1.9158936898128136E-44 1.0788254274966199E-57 3.4394472096926384E-72 0.0000000000000000E+00 5.4878214115035297E-90 --- ---
- 76: 3.3242477732292700E+32 3.3953174383919500E+07 3.7288477127585416E+01 1.7024919463438284E+09 4.8046870464867693E+08 9.8411731230069222E+26 1.5205499696185715E+18 8.8015169287573991E-01 0.0000000000000000E+00 1.3737815957497194E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7384135716315282E-12 4.9699717615298883E-01 0.0000000000000000E+00 4.9802905904253691E-01 4.9544021369904712E-03 1.9359951751555831E-05 2.7129859764329491E-09 7.2984892364654534E-16 1.1477110170751816E-23 3.5394357765446857E-33 1.9116190900665716E-44 1.0757681605943543E-57 3.4277005463394759E-72 0.0000000000000000E+00 5.4661959768013076E-90 --- ---
- 77: 3.4558346558849076E+32 3.4485286719666719E+07 3.7866806368714286E+01 1.6805451176495612E+09 4.7676010413844275E+08 9.6713420321123733E+26 1.5130663546980032E+18 8.8039182303357777E-01 0.0000000000000000E+00 1.3737809992387366E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6833544316894835E-12 4.9699793525045555E-01 0.0000000000000000E+00 4.9802955893806772E-01 4.9531497505858283E-03 1.9353347098344047E-05 2.7111012790711967E-09 7.2911461157409402E-16 1.1461168683103921E-23 3.5330521827272840E-33 1.9071888004705238E-44 1.0726003475873666E-57 3.4155321276824839E-72 0.0000000000000000E+00 5.4437992261719423E-90 --- ---
- 78: 3.5949549650650617E+32 3.5037937686749451E+07 3.8467154935930139E+01 1.6577566079506781E+09 4.7288956786104649E+08 9.4957910114568826E+26 1.5052273368394086E+18 8.8064513961402768E-01 0.0000000000000000E+00 1.3737803815892375E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6269351820226614E-12 4.9699872124907973E-01 0.0000000000000000E+00 4.9803007654734388E-01 4.9518529840706206E-03 1.9346507720524346E-05 2.7091504358830917E-09 7.2835459984288233E-16 1.1444672290188916E-23 3.5264475664617919E-33 1.9026061328670588E-44 1.0693244489860983E-57 3.4029517754081177E-72 0.0000000000000000E+00 5.4206498770466879E-90 --- ---
- 79: 3.7417875542041018E+32 3.5610946577242859E+07 3.9089283882152927E+01 1.6341468677709448E+09 4.6885799982266504E+08 9.3147738345208012E+26 1.4970306483419218E+18 8.8091197397908672E-01 0.0000000000000000E+00 1.3737797432493723E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5693114862485708E-12 4.9699953357863402E-01 0.0000000000000000E+00 4.9803061149491612E-01 4.9505127780585930E-03 1.9339438679190662E-05 2.7071348858918993E-09 7.2756946373262140E-16 1.1427633726827647E-23 3.5196271459091538E-33 1.8978748131913380E-44 1.0659432250454096E-57 3.3899704749461382E-72 0.0000000000000000E+00 5.3967688088222556E-90 --- ---
- 80: 3.8964939972735609E+32 3.6204093169448510E+07 3.9732908714125081E+01 1.6097402495970304E+09 4.6466687947662443E+08 9.1285760258192747E+26 1.4884749525578834E+18 8.8119264274379583E-01 0.0000000000000000E+00 1.3737790847115059E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5106511294148239E-12 4.9700037161261978E-01 0.0000000000000000E+00 4.9803116336829140E-01 4.9491301659814338E-03 1.9332145532506823E-05 2.7050562098213174E-09 7.2675983399823947E-16 1.1410066942281921E-23 3.5125966298424567E-33 1.8929989118512545E-44 1.0624596856055139E-57 3.3766001809243824E-72 0.0000000000000000E+00 5.3721787014385090E-90 --- ---
- 81: 4.0592167942119814E+32 3.6817121000756919E+07 4.0397703060096738E+01 1.5845649059336643E+09 4.6031826270787317E+08 8.9375131898980863E+26 1.4795598580227668E+18 8.8148744654448308E-01 0.0000000000000000E+00 1.3737784064947400E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4511316012587778E-12 4.9700123469051483E-01 0.0000000000000000E+00 4.9803173173257920E-01 4.9477062373921342E-03 1.9324634138767081E-05 2.7029160755791422E-09 7.2592637550029431E-16 1.1391986636953157E-23 3.5053620319179803E-33 1.8879827145415309E-44 1.0588769973479336E-57 3.3628534592269475E-72 0.0000000000000000E+00 5.3469033735726138E-90 --- ---
- 82: 4.2300776145254535E+32 3.7449740571499579E+07 4.1083302460087083E+01 1.5586526570680599E+09 4.5581478007309294E+08 8.7419290496788268E+26 1.4702859286886239E+18 8.8179666881786933E-01 0.0000000000000000E+00 1.3737777091063581E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3909358141902058E-12 4.9700212216683304E-01 0.0000000000000000E+00 4.9803231616279442E-01 4.9462420570310101E-03 1.9316910226344905E-05 2.7007161171246518E-09 7.2506973992731496E-16 1.1373407236987023E-23 3.4979292600882554E-33 1.8828304371997267E-44 1.0551982798110712E-57 3.3487427026643361E-72 0.0000000000000000E+00 5.3209663376492978E-90 --- ---
- 83: 4.4091755965041985E+32 3.8101632414616406E+07 4.1789308537579515E+01 1.5320388303729000E+09 4.5115963350416195E+08 8.5421932201249229E+26 1.4606546901945011E+18 8.8212057472281968E-01 0.0000000000000000E+00 1.3737769929440692E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3302429839433908E-12 4.9700303353553166E-01 0.0000000000000000E+00 4.9803291632577867E-01 4.9447384595854623E-03 1.9308978308309226E-05 2.6984576265683686E-09 7.2419044585838041E-16 1.1354340293733902E-23 3.4903030762873436E-33 1.8775455048146618E-44 1.0514260903551542E-57 3.3342781550098905E-72 0.0000000000000000E+00 5.2943871670932185E-90 --- ---
- 84: 4.5965857198159911E+32 3.8772449977328286E+07 4.2515294520177136E+01 1.5047620731222658E+09 4.4635659491864073E+08 8.3386987456042136E+26 1.4506686327075034E+18 8.8245941064410038E-01 0.0000000000000000E+00 1.3737762580204802E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.2692055413300854E-12 4.9700396878063646E-01 0.0000000000000000E+00 4.9803353221109325E-01 4.9431954712236600E-03 1.9300838628777870E-05 2.6961406860948875E-09 7.2328854088608804E-16 1.1334787160564978E-23 3.4824841686766943E-33 1.8721285235358588E-44 1.0475609776233544E-57 3.3194623677267860E-72 0.0000000000000000E+00 5.2671713163811820E-90 --- ---
- 85: 4.7923572693506620E+32 3.9461822272412568E+07 4.3260815441270566E+01 1.4768641408284252E+09 4.4141001817746955E+08 8.1318594312568705E+26 1.4403312104695045E+18 8.8281340583128398E-01 0.0000000000000000E+00 1.3737755030942468E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.2078805038072340E-12 4.9700492948192904E-01 0.0000000000000000E+00 4.9803416485913943E-01 4.9416104854151975E-03 1.9292477538892921E-05 2.6937614311176583E-09 7.2236253673458858E-16 1.1314715919536096E-23 3.4744599305727655E-33 1.8665708969781973E-44 1.0435969308247219E-57 3.3042727721979909E-72 0.0000000000000000E+00 5.2392781347715241E-90 --- ---
- 86: 4.9965124080893332E+32 4.0169356267858386E+07 4.4025435685129381E+01 1.4483896627687852E+09 4.3632490963239098E+08 7.9221070001707174E+26 1.4296468386254280E+18 8.8318278248104787E-01 0.0000000000000000E+00 1.3737747224479705E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1459833147149094E-12 4.9700592291533391E-01 0.0000000000000000E+00 4.9803481906136565E-01 4.9399714980318879E-03 1.9283831812591942E-05 2.6913019035551828E-09 7.2140546198931517E-16 1.1293975872453249E-23 3.4661702957569196E-33 1.8608311815993434E-44 1.0395045308372648E-57 3.2885971785692516E-72 0.0000000000000000E+00 5.2105025257083410E-90 --- ---
- 87: 5.2090448764490796E+32 4.0894638995428950E+07 4.4808832300217894E+01 1.4193858839130218E+09 4.3110729305056006E+08 7.7098881092704695E+26 1.4186208901531817E+18 8.8356780816711933E-01 0.0000000000000000E+00 1.3737738895002764E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0816602648660827E-12 4.9700698290791656E-01 0.0000000000000000E+00 4.9803551709380423E-01 4.9382227003483877E-03 1.9274607162500539E-05 2.6886784550212665E-09 7.2038479226653524E-16 1.1271862835239342E-23 3.4573340810840433E-33 1.8547149261748793E-44 1.0351453461837929E-57 3.2719061450774187E-72 0.0000000000000000E+00 5.1798739780969121E-90 --- ---
- 88: 5.4299188350019514E+32 4.1637239348558068E+07 4.5621440186384511E+01 1.3899024232104537E+09 4.2576258482524127E+08 7.4956612576102524E+26 1.4072596663940948E+18 8.8396834853900130E-01 0.0000000000000000E+00 1.3737730394881615E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0178810593186069E-12 4.9700806461795133E-01 0.0000000000000000E+00 4.9803622942703601E-01 4.9364380730577964E-03 1.9265193926528000E-05 2.6860021649064331E-09 7.1934376823756886E-16 1.1249314229881699E-23 3.4483261363058027E-33 1.8484818234540423E-44 1.0307046679306561E-57 3.2549099112985546E-72 0.0000000000000000E+00 5.1486971220430485E-90 --- ---
- 89: 5.6590678666849841E+32 4.2396709596242838E+07 4.6455970815281717E+01 1.3599909536516910E+09 4.2027678387662745E+08 7.2798936207000530E+26 1.3955703806094226E+18 8.8438170213664236E-01 0.0000000000000000E+00 1.3737721699559255E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.9547129053554620E-12 4.9700917117061383E-01 0.0000000000000000E+00 4.9803695811909537E-01 4.9346124600622761E-03 1.9255565000203678E-05 2.6832653855101086E-09 7.1827943670545270E-16 1.1226266621755437E-23 3.4391213522027315E-33 1.8421147021391651E-44 1.0261704427855366E-57 3.2375630340248760E-72 0.0000000000000000E+00 5.1168897819988059E-90 --- ---
- 90: 5.8963941536053810E+32 4.3172586591128252E+07 4.7311130543773778E+01 1.3297049190628486E+09 4.1469609262193966E+08 7.0630578454462204E+26 1.3835612612289902E+18 8.8481390592398501E-01 0.0000000000000000E+00 1.3737712794628081E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8923065432122678E-12 4.9701030439950145E-01 0.0000000000000000E+00 4.9803770437746581E-01 4.9327428361532564E-03 1.9245704515227603E-05 2.6804636714890236E-09 7.1719009102930296E-16 1.1202683607076122E-23 3.4297054300397301E-33 1.8356038813577450E-44 1.0215359623751221E-57 3.2198405578518592E-72 0.0000000000000000E+00 5.0844074145044317E-90 --- ---
- 91: 6.1417678423078713E+32 4.3964392661268875E+07 4.8181716408955005E+01 1.2990992684067252E+09 4.0900459250132787E+08 6.8456288391303573E+26 1.3712413134331779E+18 8.8526170178227426E-01 0.0000000000000000E+00 1.3737704834198990E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8386973688822012E-12 4.9701131743390436E-01 0.0000000000000000E+00 4.9803837148434815E-01 4.9310715115104707E-03 1.9236890430019306E-05 2.6779600889766700E-09 7.1621688673885375E-16 1.1181620758685808E-23 3.4212982434741224E-33 1.8297927650530670E-44 1.0174014820383019E-57 3.2040375421701048E-72 0.0000000000000000E+00 5.0554558841832652E-90 --- ---
- 92: 6.3950266099171614E+32 4.4771636295144081E+07 4.9067091171216816E+01 1.2682300176762495E+09 4.0321338254552013E+08 6.6280805852657209E+26 1.3586204984354586E+18 8.8572542214130046E-01 0.0000000000000000E+00 1.3737696707200534E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7862643907223405E-12 4.9701235166719976E-01 0.0000000000000000E+00 4.9803905255066949E-01 4.9293652124247703E-03 1.9227892506242848E-05 2.6754051309972783E-09 7.1522394542761023E-16 1.1160136845005617E-23 3.4127256150414631E-33 1.8238695840475176E-44 1.0131892962115856E-57 3.1879452715741968E-72 0.0000000000000000E+00 5.0259877577274546E-90 --- ---
- 93: 6.6559754419100693E+32 4.5593812489771597E+07 4.9966605257528947E+01 1.2371540567078078E+09 3.9733040043757504E+08 6.4108830199437674E+26 1.3457096137712059E+18 8.8620503776180581E-01 0.0000000000000000E+00 1.3737688419405467E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7352111660915083E-12 4.9701340636483898E-01 0.0000000000000000E+00 4.9803974709270638E-01 4.9276251507210074E-03 1.9218717189437217E-05 2.6728006770870304E-09 7.1421201227691187E-16 1.1138248361372885E-23 3.4039942861944385E-33 1.8178391344254361E-44 1.0089029366360384E-57 3.1715776951526473E-72 0.0000000000000000E+00 4.9960293511912680E-90 --- ---
- 94: 6.9243866304249961E+32 4.6430402875631697E+07 5.0879596862413585E+01 1.2059287876918533E+09 3.9136391101358134E+08 6.1944989982132472E+26 1.3325202910461891E+18 8.8670047636518390E-01 0.0000000000000000E+00 1.3737679977070503E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6857418373996950E-12 4.9701448073068427E-01 0.0000000000000000E+00 4.9804045458617180E-01 4.9258526398434782E-03 1.9209371457598694E-05 2.6701487580374815E-09 7.1318189078153884E-16 1.1115973054235787E-23 3.3951114925446831E-33 1.8117065490601518E-44 1.0045461702357921E-57 3.1549496430632864E-72 0.0000000000000000E+00 4.9656085627661591E-90 --- ---
- 95: 7.1999999999999965E+32 4.7280875614325613E+07 5.1805391827176550E+01 1.1746118062808378E+09 3.8532247211657178E+08 5.9793813803254457E+26 1.3190649683889431E+18 8.8721161975006013E-01 0.0000000000000000E+00 1.3737671386930124E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6380607199616433E-12 4.9701557390779549E-01 0.0000000000000000E+00 4.9804117446673468E-01 4.9240490935572060E-03 1.9199862814680830E-05 2.6674515533616488E-09 7.1213444167445044E-16 1.1093329894897886E-23 3.3860849521734929E-33 1.8054772884942938E-44 1.0001229917266423E-57 3.1380767948970960E-72 0.0000000000000000E+00 4.9347548090750645E-90 --- ---
- 96: 7.4825233654680658E+32 4.8144685089927301E+07 5.2743303333957201E+01 1.1432605861267288E+09 3.7921489900186396E+08 5.7659702653067932E+26 1.3053568612295388E+18 8.8773830086328609E-01 0.0000000000000000E+00 1.3737662656189984E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5923718810413872E-12 4.9701668497926754E-01 0.0000000000000000E+00 4.9804190613057203E-01 4.9222160245648537E-03 1.9190199283544505E-05 2.6647113886496034E-09 7.1107058180344581E-16 1.1070339052241213E-23 3.3769228535314219E-33 1.7991571315325629E-44 9.9563761601571534E-58 3.1209756472286937E-72 0.0000000000000000E+00 4.9034989599699049E-90 --- ---
- 97: 7.7716466101759362E+32 4.9021311850933582E+07 5.3692675171776308E+01 1.1119314322735040E+09 3.7305008165757328E+08 5.5546854496172979E+26 1.2914095995804572E+18 8.8828031379792527E-01 0.0000000000000000E+00 1.3737653792305720E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5488775223119879E-12 4.9701781299638137E-01 0.0000000000000000E+00 4.9804264895290851E-01 4.9203549980610800E-03 1.9180389161259224E-05 2.6619306656040951E-09 7.0999125687351329E-16 1.1047021300859793E-23 3.3676336184163988E-33 1.7927520107442195E-44 9.9109436059068363E-58 3.1036630619554298E-72 0.0000000000000000E+00 4.8718725075303068E-90 --- ---
- 98: 8.0670300945172416E+32 4.9910222981137879E+07 5.4652838527145938E+01 1.0806792473918674E+09 3.6683695270827264E+08 5.3459247146446549E+26 1.2772371937785679E+18 8.8883741164177843E-01 0.0000000000000000E+00 1.3737644802982736E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5077774953845140E-12 4.9701895697862691E-01 0.0000000000000000E+00 4.9804340228803146E-01 4.9184676316947236E-03 1.9170441019049362E-05 2.6591118616059967E-09 7.0889744121418227E-16 1.1023398014116294E-23 3.3582258984258060E-33 1.7862680093471240E-44 9.8649764273013640E-58 3.0861562535211152E-72 0.0000000000000000E+00 4.8399075391389610E-90 --- ---
- 99: 8.3683057110728352E+32 5.0810871284311064E+07 5.5623111234958991E+01 1.0495579679782509E+09 3.6058458769816476E+08 5.1400666525454341E+26 1.2628543050000758E+18 8.8940929214458864E-01 0.0000000000000000E+00 1.3737635696360394E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4692687231278802E-12 4.9702011589026573E-01 0.0000000000000000E+00 4.9804416545385843E-01 4.9165556342347840E-03 1.9160363906102158E-05 2.6562575870104658E-09 7.0779015992785737E-16 1.0999491640103757E-23 3.3487087635166231E-33 1.7797114903195143E-44 9.8185207029828544E-58 3.0684731319689257E-72 0.0000000000000000E+00 4.8076373592517034E-90 --- ---
- 100: 8.6750781544790573E+32 5.1722694355371252E+07 5.6602796958018992E+01 1.0186203000994186E+09 3.5430216792786658E+08 4.9374687940164546E+26 1.2482762103098765E+18 8.8999559493487024E-01 0.0000000000000000E+00 1.3737626481005512E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4335421860049502E-12 4.9702128864115380E-01 0.0000000000000000E+00 4.9804493773247915E-01 4.9146208042126502E-03 1.9150167342281719E-05 2.6533705825889587E-09 7.0667048779189827E-16 1.0975325675096212E-23 3.3390916902455873E-33 1.7730890872736191E-44 9.7716243438646372E-58 3.0506322716030001E-72 0.0000000000000000E+00 4.7750964266219376E-90 --- ---
- 101: 8.9869263997885493E+32 5.2645113558241323E+07 5.7591184319264009E+01 9.8791746887080920E+08 3.4799894279876149E+08 4.7384659653368278E+26 1.2335187657662804E+18 8.9059589887921609E-01 0.0000000000000000E+00 1.3737617165906578E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4007775896455763E-12 4.9702247408748212E-01 0.0000000000000000E+00 4.9804571837064393E-01 4.9126650286999115E-03 1.9139861311490420E-05 2.6504537171731021E-09 7.0553954823761000E-16 1.0950924638677127E-23 3.3293845506835460E-33 1.7664076958010326E-44 9.7243370229738817E-58 3.0326528809974708E-72 0.0000000000000000E+00 4.7423202940765943E-90 --- ---
- 102: 9.3034053808593111E+32 5.3577532930703938E+07 5.8587546008578563E+01 9.5749898346146369E+08 3.4168419188071185E+08 4.5433688847563005E+26 1.2185983674941860E+18 8.9120971964132889E-01 0.0000000000000000E+00 1.3737607760467339E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3711343897770737E-12 4.9702367103258716E-01 0.0000000000000000E+00 4.9804650658029787E-01 4.9106902819715074E-03 1.9129456254372349E-05 2.6475099851262484E-09 7.0439851226174413E-16 1.0926314047436402E-23 3.3195976007711639E-33 1.7596744644453174E-44 9.6767101027830389E-58 3.0145547721097833E-72 0.0000000000000000E+00 4.7093455467793893E-90 --- ---
- 103: 9.6240478581360333E+32 5.4519338036760658E+07 5.9591137887903479E+01 9.2741241924931347E+08 3.3536718692220312E+08 4.3524630051846033E+26 1.2035319109677742E+18 8.9183650750138310E-01 0.0000000000000000E+00 1.3737598274502108E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3447376568087533E-12 4.9702487822755115E-01 0.0000000000000000E+00 4.9804730153897675E-01 4.9086986245141413E-03 1.9118963062794479E-05 2.6445425043289377E-09 7.0324859753731469E-16 1.0901520393003111E-23 3.3097414704159937E-33 1.7528967868901977E-44 9.6287965713201398E-58 2.9963583328092675E-72 0.0000000000000000E+00 4.6762097468709768E-90 --- ---
- 104: 9.9483664631032995E+32 5.5469894787313811E+07 6.0601198115571997E+01 8.9770321856230819E+08 3.2905715404049712E+08 4.1660076069719166E+26 1.1883367483814764E+18 8.9247564550347969E-01 0.0000000000000000E+00 1.3737588718229715E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3216577793334275E-12 4.9702609437196860E-01 0.0000000000000000E+00 4.9804810239031205E-01 4.9066922017624807E-03 1.9108393072862027E-05 2.6415545137587028E-09 7.0209106736794827E-16 1.0876571116751417E-23 3.2998271522892202E-33 1.7460822932757371E-44 9.5806509723364922E-58 2.9780844972436895E-72 0.0000000000000000E+00 4.6429513743520068E-90 --- ---
- 105: 1.0275855904722873E+33 5.6428548250437431E+07 6.1616946313081762E+01 8.6841451123473847E+08 3.2276323632359159E+08 3.9842351414056173E+26 1.1730306443811218E+18 8.9312644800055963E-01 0.0000000000000000E+00 1.3737579102268525E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3018853094922236E-12 4.9702731811457984E-01 0.0000000000000000E+00 4.9804890824444858E-01 4.9046732430532390E-03 1.9097758059057862E-05 2.6385493713972557E-09 7.0092722977075055E-16 1.0851494587344303E-23 3.2898659917817983E-33 1.7392388423419752E-44 9.5323293416166829E-58 2.9597547186597045E-72 0.0000000000000000E+00 4.6096097726586875E-90 --- ---
- 106: 1.0605995321344584E+33 5.7394621473092191E+07 6.2637582796609841E+01 8.3958695599068165E+08 3.1649445708922982E+08 3.8073508224641773E+26 1.1576317300823265E+18 8.9378815967015957E-01 0.0000000000000000E+00 1.3737569437629919E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2853070291388501E-12 4.9702854805410257E-01 0.0000000000000000E+00 4.9804971817859256E-01 4.9026440602542160E-03 1.9087070226650255E-05 2.6355305516595378E-09 6.9975843637646302E-16 1.0826320074426196E-23 3.2798696754702195E-33 1.7323745125859570E-44 9.4838891366771866E-58 2.9413909398597058E-72 0.0000000000000000E+00 4.5762250902012679E-90 --- ---
- 107: 1.0938250759929178E+33 5.8367414336870909E+07 6.3662287895819986E+01 8.1125860343588054E+08 3.1025968403723615E+08 3.6355324613817045E+26 1.1421584555989155E+18 8.9445995507524556E-01 0.0000000000000000E+00 1.3737559735711882E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2716948762265933E-12 4.9702978274004589E-01 0.0000000000000000E+00 4.9805053123754894E-01 4.9006070464195344E-03 1.9076342204221155E-05 2.6325016428721299E-09 6.9858608135231200E-16 1.0801077722917776E-23 3.2698502198726535E-33 1.7254975936656518E-44 9.4353891686508830E-58 2.9230155646645571E-72 0.0000000000000000E+00 4.5428382240481925E-90 --- ---
- 108: 1.1272077762965457E+33 5.9346202471223228E+07 6.4690221384369323E+01 7.8346478120269775E+08 3.0406759453970474E+08 3.4689305357626556E+26 1.1266295410995333E+18 8.9514093884578316E-01 0.0000000000000000E+00 1.3737550008290414E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2607195117705978E-12 4.9703102067380001E-01 0.0000000000000000E+00 4.9805134643443899E-01 4.8985646739921071E-03 1.9065587033795233E-05 2.6294663440934102E-09 6.9741160007469451E-16 1.0775798522063476E-23 3.2598199581841413E-33 1.7186165764733801E-44 9.3868895253105094E-58 2.9046514262252049E-72 0.0000000000000000E+00 4.5094907582496210E-90 --- ---
- 109: 1.1606924042224911E+33 6.0330236248581715E+07 6.5720522042701248E+01 7.5623800155265415E+08 2.9792664229926521E+08 3.3076684823817375E+26 1.1110639265520412E+18 8.9583014655265902E-01 0.0000000000000000E+00 1.3737540267509502E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2519895097033283E-12 4.9703226030991665E-01 0.0000000000000000E+00 4.9805216275154474E-01 4.8965194926908172E-03 1.9054818159302423E-05 2.6264284614864859E-09 6.9623646763483190E-16 1.0750514271056696E-23 3.2497915257301867E-33 1.7117401423989573E-44 9.3384514890098225E-58 2.8863217536554031E-72 0.0000000000000000E+00 4.4762248995422931E-90 --- ---
- 110: 1.1942232217492810E+33 6.1318739886868507E+07 6.6752307381669354E+01 7.2960789149957240E+08 2.9184502560347176E+08 3.1518432004420141E+26 1.0954807202569047E+18 8.9652654634358264E-01 0.0000000000000000E+00 1.3737530525868692E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2451016077445331E-12 4.9703350005768310E-01 0.0000000000000000E+00 4.9805297914134583E-01 4.8944741269135485E-03 1.9044049412499184E-05 2.6233919040009148E-09 6.9506219708445982E-16 1.0725257539276919E-23 3.2397778433734420E-33 1.7048771512700895E-44 9.2901374460379852E-58 2.8680501356980531E-72 0.0000000000000000E+00 4.4430834081627059E-90 --- ---
- 111: 1.2277442597660631E+33 6.2310910685963027E+07 6.7784673547649930E+01 7.0360114528042650E+08 2.8583065739141309E+08 3.0015257499975518E+26 1.0798991462674968E+18 8.9722904140327453E-01 0.0000000000000000E+00 1.3737520796207535E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2396824121068929E-12 4.9703473828310774E-01 0.0000000000000000E+00 4.9805379452782711E-01 4.8924312724613981E-03 1.9033294995338458E-05 2.6203606780822731E-09 6.9389033731454369E-16 1.0700061618875511E-23 3.2297920979926349E-33 1.6980366273802836E-44 9.2420107833550265E-58 2.8498604799440670E-72 0.0000000000000000E+00 4.4101095211542372E-90 --- ---
- 112: 1.2611995981071659E+33 6.3305918425810508E+07 6.8816695436858524E+01 6.7824149877028871E+08 2.7989113733219445E+08 2.8567622284794911E+26 1.0643384908579272E+18 8.9793647329138793E-01 0.0000000000000000E+00 1.3737511091686757E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2354112608633779E-12 4.9703597331131216E-01 0.0000000000000000E+00 4.9805460780805433E-01 4.8903936925923548E-03 1.9022569458841696E-05 2.6173388814309649E-09 6.9272247057706348E-16 1.0674960469969409E-23 3.2198477201545735E-33 1.6912277437023582E-44 9.1941357735290927E-58 2.8317769679618526E-72 0.0000000000000000E+00 4.3773468688961618E-90 --- ---
- 113: 1.2945336451787247E+33 6.4302904954889834E+07 6.9847427043234248E+01 6.5354972521973729E+08 2.7403372610148650E+08 2.7175748068408207E+26 1.0488180481311713E+18 8.9864762620018190E-01 0.0000000000000000E+00 1.3737501425765366E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2320259827825923E-12 4.9703720342944557E-01 0.0000000000000000E+00 4.9805541785409285E-01 4.8883642132133819E-03 1.9011887677472490E-05 2.6143306955362851E-09 6.9156020954573465E-16 1.0649988656248037E-23 3.2099583581277312E-33 1.6844598037195628E-44 9.1465774440092229E-58 2.8138240049235423E-72 0.0000000000000000E+00 4.3448393823691305E-90 --- ---
- 114: 1.3276914148488799E+33 6.5300983998671211E+07 7.0875902063181385E+01 6.2954365148723602E+08 2.6826532202063689E+08 2.5839629057456150E+26 1.0333570648909157E+18 8.9936123215911812E-01 0.0000000000000000E+00 1.3737491812172921E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2293185587861328E-12 4.9703842689021149E-01 0.0000000000000000E+00 4.9805622351533052E-01 4.8863457170620350E-03 1.9001264818232969E-05 2.6113403767751307E-09 6.9040519383618817E-16 1.0625181269332681E-23 3.2001378475988221E-33 1.6777422204532739E-44 9.0994014279106013E-58 2.7960261627117395E-72 0.0000000000000000E+00 4.3126311893979638E-90 --- ---
- 115: 1.3606187983049275E+33 6.6299241218400948E+07 7.1901134784769170E+01 6.0623819375122285E+08 2.6259244020106080E+08 2.4559044914957195E+26 1.0179746849506428E+18 9.0007597719653365E-01 0.0000000000000000E+00 1.3737482264877020E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2271268570309347E-12 4.9703964191600847E-01 0.0000000000000000E+00 4.9805702362120435E-01 4.8843411368753465E-03 1.8990716304477158E-05 2.6083722460823850E-09 6.8925908599025172E-16 1.0600573842035085E-23 3.1904001771697388E-33 1.6710844927562259E-44 9.0526737969319231E-58 2.7784081167898004E-72 0.0000000000000000E+00 4.2807665004643184E-90 --- ---
- 116: 1.3932628286393314E+33 6.7296734550965875E+07 7.2922121282243509E+01 5.8364541151744258E+08 2.5702119431097120E+08 2.3333574709974392E+26 1.0026898929326122E+18 9.0079050844845243E-01 0.0000000000000000E+00 1.3737472798044944E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2253259365764139E-12 4.9704084670380810E-01 0.0000000000000000E+00 4.9805781698441304E-01 4.8823534473415109E-03 1.8980257773373384E-05 2.6054306769003287E-09 6.8812356681317359E-16 1.0576202248172784E-23 3.1807594487257960E-33 1.6644961782645906E-44 9.0064608722714806E-58 2.7609945753222871E-72 0.0000000000000000E+00 4.2492894814252205E-90 --- ---
- 117: 1.4255719360108027E+33 6.8292494860617250E+07 7.3937840939014464E+01 5.6177457858917141E+08 2.5155728105780628E+08 2.2162611650163229E+26 9.8752145776983667E+17 9.0150344218270262E-01 0.0000000000000000E+00 1.3737463425999293E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2238203358910197E-12 4.9704203943080488E-01 0.0000000000000000E+00 4.9805860240463717E-01 4.8803856557794040E-03 1.8969905026735507E-05 2.6025200813359763E-09 6.8700033003818014E-16 1.0552102588435027E-23 3.1712298324928129E-33 1.6579868628988663E-44 8.9608290128924911E-58 2.7438102003450684E-72 0.0000000000000000E+00 4.2182441128465328E-90 --- ---
- 118: 1.4574961913354622E+33 6.9285526932869360E+07 7.4947258320725709E+01 5.4063226954356480E+08 2.4620596744602606E+08 2.1045378392359373E+26 9.7248787600251674E+17 9.0221337268162471E-01 0.0000000000000000E+00 1.3737454163167591E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2225376824477055E-12 4.9704321826082543E-01 0.0000000000000000E+00 4.9805937867276034E-01 4.8784407915636553E-03 1.8959673975325134E-05 2.5996448945619941E-09 6.8589107633378905E-16 1.0528311062668825E-23 3.1618255169447242E-33 1.6515661270367454E-44 8.9158443821067648E-58 2.7268795213877679E-72 0.0000000000000000E+00 4.1876740367393835E-90 --- ---
- 119: 1.4889875365948238E+33 7.0274810839821845E+07 7.5949325409220478E+01 5.2022246015647346E+08 2.4097208084623453E+08 1.9980942731980592E+26 9.5760731500952435E+17 9.0291888190315073E-01 0.0000000000000000E+00 1.3737445024024849E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2214235404830709E-12 4.9704438135164147E-01 0.0000000000000000E+00 4.9806014457568437E-01 4.8765218940597889E-03 1.8949580575394771E-05 2.5968095571215475E-09 6.8479750652423986E-16 1.0504863825836542E-23 3.1525606524880119E-33 1.6452435076351829E-44 8.8715726874966550E-58 2.7102268397037963E-72 0.0000000000000000E+00 4.1576223874152531E-90 --- ---
- 120: 1.5199999999999995E+33 7.1259303704375118E+07 7.6942984224369610E+01 5.0054664014229721E+08 2.3586000187741524E+08 1.8968233480340057E+26 9.4289755634909030E+17 9.0361854981240519E-01 0.0000000000000000E+00 1.3737436023029227E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2204373054173277E-12 4.9704552686315606E-01 0.0000000000000000E+00 4.9806089890172034E-01 4.8746319991189203E-03 1.8939640757740069E-05 2.5940184952179415E-09 6.8372131405549462E-16 1.0481796828369214E-23 3.1434492892203024E-33 1.6390284565135157E-44 8.8280788957309404E-58 2.6938761237183357E-72 0.0000000000000000E+00 4.1281316076005245E-90 --- ---
- 121: 1.5504898944229376E+33 7.2237941888202056E+07 7.7927169824418328E+01 4.8160393652478701E+08 2.3087366007204750E+08 1.8006056349673307E+26 9.2837593936300941E+17 9.0431096525187493E-01 0.0000000000000000E+00 1.3737427174551639E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2195489553830252E-12 4.9704665296636513E-01 0.0000000000000000E+00 4.9806164044648954E-01 4.8727741242914858E-03 1.8929870350106599E-05 2.5912760992303607E-09 6.8266417680068868E-16 1.0459145642945147E-23 3.1345053095713495E-33 1.6329302953538817E-44 8.7854269262046392E-58 2.6778508971837794E-72 0.0000000000000000E+00 4.0992432525142231E-90 --- ---
- 122: 1.5804674455118365E+33 7.3211324387764260E+07 7.8902494654659705E+01 4.6337563302460331E+08 2.2601233839986527E+08 1.7092332249946879E+26 9.1404687656512486E+17 9.0499533069937832E-01 0.0000000000000000E+00 1.3737418485114150E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2187357794810000E-12 4.9704775883114105E-01 0.0000000000000000E+00 4.9806236866338338E-01 4.8709496391565084E-03 1.8920276508009891E-05 2.5885843198065977E-09 6.8162683076130695E-16 1.0436925625995999E-23 3.1257345988865330E-33 1.6269528809096532E-44 8.7436423686486233E-58 2.6621602430023781E-72 0.0000000000000000E+00 4.0709727790864115E-90 --- ---
- 123: 1.6099426589457796E+33 7.4180024200858131E+07 7.9869535477003438E+01 4.4582829884121293E+08 2.2127121339405793E+08 1.6224310655354588E+26 8.9990266222363354E+17 9.0567143375178094E-01 0.0000000000000000E+00 1.3737409954382068E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2179807022215378E-12 4.9704884449998110E-01 0.0000000000000000E+00 4.9806308358042173E-01 4.8691584736131732E-03 1.8910858815251713E-05 2.5859429823927071E-09 6.8060919280421354E-16 1.0415134585565051E-23 3.1171361150039222E-33 1.6210953482324654E-44 8.7027178040434946E-58 2.6468008488710738E-72 0.0000000000000000E+00 4.0433133127346975E-90 --- ---
- 124: 1.6389253255361677E+33 7.5144591748626828E+07 8.0828837092770129E+01 4.2893053935513943E+08 2.1664570571238896E+08 1.5399429159809291E+26 8.8593593706421376E+17 9.0633905454144237E-01 0.0000000000000000E+00 1.3737401582661983E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2172713619121718E-12 4.9704990993377163E-01 0.0000000000000000E+00 4.9806378517188354E-01 4.8674006922038212E-03 1.8901617563694723E-05 2.5833521118091853E-09 6.7961125688742405E-16 1.0393771988429702E-23 3.1087094739141513E-33 1.6153572840755427E-44 8.6626490005300622E-58 2.6317706113019110E-72 0.0000000000000000E+00 4.0162601785904166E-90 --- ---
- 125: 1.6674250262022876E+33 7.6105557972005397E+07 8.1780915642341697E+01 4.1265283459791690E+08 2.1213146048478055E+08 1.4615297718244693E+26 8.7213965619677222E+17 9.0699796644676500E-01 0.0000000000000000E+00 1.3737393370917403E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2165988392751545E-12 4.9705095500979662E-01 0.0000000000000000E+00 4.9806447335699577E-01 4.8656764974009583E-03 1.8892553770248520E-05 2.5808119366784160E-09 6.7863309567394791E-16 1.0372838992296544E-23 3.1004549614490082E-33 1.6097387339705469E-44 8.6234349549948531E-58 2.6170686482074080E-72 0.0000000000000000E+00 3.9898109189407929E-90 --- ---
- 126: 1.6954511368242891E+33 7.7063437154736668E+07 8.2726261545570765E+01 3.9696739401352251E+08 2.0772432960699528E+08 1.3869684503471491E+26 8.5850706007370726E+17 9.0764793675608302E-01 0.0000000000000000E+00 1.3737385320792582E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2159567306188434E-12 4.9705197951870450E-01 0.0000000000000000E+00 4.9806514799793600E-01 4.8639862346098279E-03 1.8883669202879074E-05 2.5783228963904927E-09 6.7767486312625235E-16 1.0352338499068551E-23 3.0923735533183379E-33 1.6042402150220961E-44 8.5850779748869084E-58 2.6026953267000991E-72 0.0000000000000000E+00 3.9639653382771818E-90 --- ---
- 127: 1.7230128329767566E+33 7.8018729517595947E+07 8.3665342126878784E+01 3.8184802550323743E+08 2.0342035572933066E+08 1.3160503179799679E+26 8.4503164806286144E+17 9.0828872729322951E-01 0.0000000000000000E+00 1.3737377434645502E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2153404732387762E-12 4.9705298316031099E-01 0.0000000000000000E+00 4.9806580889706908E-01 4.8623303990942201E-03 1.8874966416728723E-05 2.5758856509072721E-09 6.7673679819546482E-16 1.0332275231591787E-23 3.0844669444295476E-33 1.5988627350427876E-44 8.5475838044963295E-58 2.5886523076473057E-72 0.0000000000000000E+00 3.9387255786438092E-90 --- ---
- 128: 1.7501190945459738E+33 7.8971923622409120E+07 8.4598603973534694E+01 3.6727001703623736E+08 1.9921575772556305E+08 1.2485801423235157E+26 8.3170715430336922E+17 9.0892009501308935E-01 0.0000000000000000E+00 1.3737369715591544E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2147468554731129E-12 4.9705396553803838E-01 0.0000000000000000E+00 4.9806645579328535E-01 4.8607096451504768E-03 1.8866448802050748E-05 2.5735010938771100E-09 6.7581922978585123E-16 1.0312655837709319E-23 3.0767375889837115E-33 1.5936078190321913E-44 8.5109618025788936E-58 2.5749426095163245E-72 0.0000000000000000E+00 3.9140962297686388E-90 --- ---
- 129: 1.7767787102338976E+33 7.9923498619569466E+07 8.5526475060182960E+01 3.5321002935210931E+08 1.9510691745944732E+08 1.1843750542032427E+26 8.1852752548051366E+17 9.0954179257480383E-01 0.0000000000000000E+00 1.3737362167558429E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2141736618400793E-12 4.9705492615192581E-01 0.0000000000000000E+00 4.9806708835739821E-01 4.8591247976389378E-03 1.8858120644528230E-05 2.5711703692149387E-09 6.7492258305275992E-16 1.0293489022832733E-23 3.0691887518105657E-33 1.5884775433014455E-44 8.4752251733165500E-58 2.5615706922117586E-72 0.0000000000000000E+00 3.8900844751624963E-90 --- ---
- 130: 1.8030002819517733E+33 8.0873926368846312E+07 8.6449366666641737E+01 3.3964599848464459E+08 1.9109036769048470E+08 1.1232636071444771E+26 8.0548690029852288E+17 9.1015356889902588E-01 0.0000000000000000E+00 1.3737354795354840E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2136194171160036E-12 4.9705586438989247E-01 0.0000000000000000E+00 4.9806770618639140E-01 4.8575768663988465E-03 1.8849987200737429E-05 2.5688948919157680E-09 6.7404738732832173E-16 1.0274785717291312E-23 3.0618245733947651E-33 1.5834745788986308E-44 8.4403912620418171E-58 2.5485425651420806E-72 0.0000000000000000E+00 3.8667002817275240E-90 --- ---
- 131: 1.8287922291062446E+33 8.1823673460172027E+07 8.7367675121758722E+01 3.2655704700788933E+08 1.8716278098272657E+08 1.0650849233455407E+26 7.9257959037563482E+17 9.1075516971553183E-01 0.0000000000000000E+00 1.3737347604755005E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2130832029327323E-12 4.9705677951697619E-01 0.0000000000000000E+00 4.9806830879633246E-01 4.8560670640028407E-03 1.8842054791147961E-05 2.5666763737660824E-09 6.7319428592917956E-16 1.0256559283859730E-23 3.0546501507057476E-33 1.5786022457576729E-44 8.4064819255233534E-58 2.5358659231379972E-72 0.0000000000000000E+00 3.8439566393053924E-90 --- ---
- 132: 1.8541627927807330E+33 8.2773203158667594E+07 8.8281783390660664E+01 3.1392340305033743E+08 1.8332095949834388E+08 1.0096879166605810E+26 7.7980006236211443E+17 9.1134633810897503E-01 0.0000000000000000E+00 1.3737340602602485E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2125645277192137E-12 4.9705767066211792E-01 0.0000000000000000E+00 4.9806889561367079E-01 4.8545968275594716E-03 1.8834330914377476E-05 2.5645168549880587E-09 6.7236404824291519E-16 1.0238825773905899E-23 3.0476716371398806E-33 1.5738645798054671E-44 8.3735239922564883E-58 2.5235503159545013E-72 0.0000000000000000E+00 3.8218698603775906E-90 --- ---
- 133: 1.8791200398147914E+33 8.3722977296326175E+07 8.9192062523163528E+01 3.0172632624644893E+08 1.7956182557692003E+08 9.5693058432335779E+25 7.6714292109565274E+17 9.1192681506770068E-01 0.0000000000000000E+00 1.3737333796937008E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2120632360771601E-12 4.9705853680202666E-01 0.0000000000000000E+00 4.9806946596461288E-01 4.8531678453348362E-03 1.8826824386746976E-05 2.5624187429427241E-09 6.7155758452474676E-16 1.0221604241342334E-23 3.0408963651739009E-33 1.5692664154576676E-44 8.3415498295525726E-58 2.5116073575886888E-72 0.0000000000000000E+00 3.8004599510198339E-90 --- ---
- 134: 1.9036718667840526E+33 8.4673458131449208E+07 9.0098872984786567E+01 2.8994803989892286E+08 1.7588241300959209E+08 9.0667936018010543E+25 7.5460289361027763E+17 9.1249634004461699E-01 0.0000000000000000E+00 1.3737327197151314E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2115794477739530E-12 4.9705937674121214E-01 0.0000000000000000E+00 4.9807001906197429E-01 4.8517820896940671E-03 1.8819545515015305E-05 2.5603848600888412E-09 6.7077596424747281E-16 1.0204917132346262E-23 3.0343329987821114E-33 1.5648134882761084E-44 8.3105980504993927E-58 2.5000509877216113E-72 0.0000000000000000E+00 3.7797510750985974E-90 --- ---
- 135: 1.9278260038833399E+33 8.5625110196067065E+07 9.1002565876712708E+01 2.7857166871552330E+08 1.7227985893883061E+08 8.5880852309310880E+25 7.4217481384809856E+17 9.1305465153679088E-01 0.0000000000000000E+00 1.3737320814184356E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2111135192671471E-12 4.9706018908739735E-01 0.0000000000000000E+00 4.9807055398898886E-01 4.8504418576670013E-03 1.8812506309138020E-05 2.5584185031038756E-09 6.7002043873559649E-16 1.0188790766410841E-23 3.0279917217201853E-33 1.5605125619126384E-44 8.2807143893252618E-58 2.4888977958846607E-72 0.0000000000000000E+00 3.7597721306155691E-90 --- ---
- 136: 1.9515900187154163E+33 8.6578402151145890E+07 9.1903484062603980E+01 2.6758118156027406E+08 1.6875139632152340E+08 8.1319965493748296E+25 7.2985360792980992E+17 9.1360148769567873E-01 0.0000000000000000E+00 1.3737314660763488E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2106660231941543E-12 4.9706097222069545E-01 0.0000000000000000E+00 4.9807106967901238E-01 4.8491498218007469E-03 1.8805720749029839E-05 2.5565235170656840E-09 6.6929246957989964E-16 1.0173255940621890E-23 3.0218844741989907E-33 1.5563715878174851E-44 8.2519528039354001E-58 2.4781674302311904E-72 0.0000000000000000E+00 3.7405574773047877E-90 --- ---
- 137: 1.9749713199878009E+33 8.7533808669360712E+07 9.2801963209428877E+01 2.5696133872597349E+08 1.6529434691446930E+08 7.6974114327723746E+25 7.1763427983319821E+17 9.1413658697758449E-01 0.0000000000000000E+00 1.3737308751709582E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2102377428376057E-12 4.9706172425477835E-01 0.0000000000000000E+00 4.9807156488995219E-01 4.8479090942259813E-03 1.8799205120694519E-05 2.5547043889776517E-09 6.6859376447562601E-16 1.0158348692172484E-23 3.0160252516905449E-33 1.5523999070105296E-44 8.2243768700332764E-58 2.4678831148796700E-72 0.0000000000000000E+00 3.7221478582877463E-90 --- ---
- 138: 1.9979771611200066E+33 8.8491812365603536E+07 9.3698332747009559E+01 2.4669764329110608E+08 1.6190611475507718E+08 7.2832772437254396E+25 7.0551189736250650E+17 9.1465968885328608E-01 0.0000000000000000E+00 1.3737303104329897E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2098296804500648E-12 4.9706244298687408E-01 0.0000000000000000E+00 4.9807203817134138E-01 4.8467233091511507E-03 1.8792978449096056E-05 2.5529663682714765E-09 6.6792632341424518E-16 1.0144111281571311E-23 3.0104304903900421E-33 1.5486085105182466E-44 8.1980615819190844E-58 2.4580723186818413E-72 0.0000000000000000E+00 3.7045915923779886E-90 --- ---
- 139: 2.0206146437634887E+33 8.9452905796197221E+07 9.4592916758819428E+01 2.3677629617451167E+08 1.5858418014474282E+08 6.8886006266851931E+25 6.9348157826360128E+17 9.1517053459765452E-01 0.0000000000000000E+00 1.3737297738931717E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2094430796920042E-12 4.9706312583239753E-01 0.0000000000000000E+00 4.9807248782129326E-01 4.8455967307119855E-03 1.8787063064137694E-05 2.5513156244276866E-09 6.6729249912001687E-16 1.0130593479478603E-23 3.0051195718935220E-33 1.5450103805147804E-44 8.1730957127000129E-58 2.4487676322706461E-72 0.0000000000000000E+00 3.6879461386267432E-90 --- ---
- 140: 2.0428907212365411E+33 9.0417593549030647E+07 9.5486034801652025E+01 2.2718415454340532E+08 1.5532609418493867E+08 6.5124436334350762E+25 6.8153847636817779E+17 9.1566886819514814E-01 0.0000000000000000E+00 1.3737292679512192E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2090794646204056E-12 4.9706376973715571E-01 0.0000000000000000E+00 4.9807291182868974E-01 4.8445343978172706E-03 1.8781485360860669E-05 2.5497594587555045E-09 6.6669507827148611E-16 1.0117854296571857E-23 3.0001155018253524E-33 1.5416209492194209E-44 8.1495849907387419E-58 2.4400079490061713E-72 0.0000000000000000E+00 3.6722802039932498E-90 --- ---
- 141: 2.0648122018763024E+33 9.1386394448553115E+07 9.6378002661983629E+01 2.1790869326789686E+08 1.5212947400100598E+08 6.1539201487196267E+25 6.6967776762370790E+17 9.1615443741481328E-01 0.0000000000000000E+00 1.3737287954714205E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2087407005387639E-12 4.9706437105569318E-01 0.0000000000000000E+00 4.9807330779307246E-01 4.8435423248582568E-03 1.8776276852909627E-05 2.5483065979502944E-09 6.6613739410660939E-16 1.0105964382340512E-23 2.9954458511068067E-33 1.5384587355861360E-44 8.1276565084422253E-58 2.4318401047249779E-72 0.0000000000000000E+00 3.6576766709578669E-90 --- ---
- 142: 2.0863857523099949E+33 9.2359843901825547E+07 9.7269133048334240E+01 2.0893796914722133E+08 1.4899199895776245E+08 5.8121925888514683E+25 6.5789463588857114E+17 9.1662699515064860E-01 0.0000000000000000E+00 1.3737283599205959E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2084290871570468E-12 4.9706492537571445E-01 0.0000000000000000E+00 4.9807367280902670E-01 4.8426277913817973E-03 1.8771475693025186E-05 2.5469676178772884E-09 6.6562348900342316E-16 1.0095009489059715E-23 2.9911441154329899E-33 1.5355462650842960E-44 8.1074650931649714E-58 2.4243212479546643E-72 0.0000000000000000E+00 3.6442368305139024E-90 --- ---
- 143: 2.1076179006474449E+33 9.3338496414701328E+07 9.8159736214440670E+01 2.0026058766029701E+08 1.4591140853708431E+08 5.4864688490086687E+25 6.4618425833951898E+17 9.1708630121088597E-01 0.0000000000000000E+00 1.3737279655782237E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2081475047314319E-12 4.9706542725065606E-01 0.0000000000000000E+00 4.9807400329008167E-01 4.8417997833015286E-03 1.8767128989043230E-05 2.5457555891634786E-09 6.6515836217870567E-16 1.0085095749896762E-23 2.9872517869801337E-33 1.5329114715721675E-44 8.0892030192864806E-58 2.4175224539108778E-72 0.0000000000000000E+00 3.6320868377170872E-90 --- ---
- 144: 2.1285150395968905E+33 9.4322928310809672E+07 9.9050120517643848E+01 1.9186567201570871E+08 1.4288550346459830E+08 5.1759994774768489E+25 6.3454179035328525E+17 9.1753212495161895E-01 0.0000000000000000E+00 1.3737276178809880E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2078996571078904E-12 4.9706586976118894E-01 0.0000000000000000E+00 4.9807429467996367E-01 4.8410697163427819E-03 1.8763296601463347E-05 2.5446871358606045E-09 6.6474837589366098E-16 1.0076358335120366E-23 2.9838217522835414E-33 1.5305899967607486E-44 8.0731159405318388E-58 2.4115346538247065E-72 0.0000000000000000E+00 3.6213883042207320E-90 --- ---
- 145: 2.1490834295060223E+33 9.5313740690502569E+07 9.9940592902440557E+01 1.8374283429017201E+08 1.3991215434685385E+08 4.8800750573255915E+25 6.2296234972046989E+17 9.1796424976258462E-01 0.0000000000000000E+00 1.3737273240509094E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2076905175450482E-12 4.9706624371579899E-01 0.0000000000000000E+00 4.9807454092618386E-01 4.8404527549500802E-03 1.8760058066783515E-05 2.5437843655179677E-09 6.6440199602542150E-16 1.0068977233854516E-23 2.9809244872575633E-33 1.5286293826980766E-44 8.0595319393649662E-58 2.4064794462329252E-72 0.0000000000000000E+00 3.6123576128902862E-90 --- ---
- 146: 2.1693292013301543E+33 9.6311562672611281E+07 1.0083145931025973E+02 1.7588214843382779E+08 1.3698933203654155E+08 4.5980237779860768E+25 6.1144100008657805E+17 9.1838248265620870E-01 0.0000000000000000E+00 1.3737270944472559E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2075272901374632E-12 4.9706653593022321E-01 0.0000000000000000E+00 4.9807473334706065E-01 4.8399706509231113E-03 1.8757527498139621E-05 2.5430790229834234E-09 6.6413138584562453E-16 1.0063211216908837E-23 2.9786613886756120E-33 1.5270980935254823E-44 8.0489240352013080E-58 2.4025323595740484E-72 0.0000000000000000E+00 3.6053074752468459E-90 --- ---
- 147: 2.1892583595293722E+33 9.7317054969889984E+07 1.0172302510716030E+02 1.6827412476329100E+08 1.3411523114373811E+08 4.3292091809602716E+25 5.9997273385413427E+17 9.1878668494499849E-01 0.0000000000000000E+00 1.3737269465184548E+01 5.0000000000000000E-01 semiconvective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2074222199360677E-12 4.9706672419789460E-01 0.0000000000000000E+00 4.9807485731979678E-01 4.8396600413265125E-03 1.8755897141792190E-05 2.5426246314665894E-09 6.6395706418600843E-16 1.0059497094193647E-23 2.9772037331678060E-33 1.5261118777692984E-44 8.0420928187774468E-58 2.3999908127041511E-72 0.0000000000000000E+00 3.6007683271015849E-90 --- ---
- 148: 2.2088767848964524E+33 9.8330917095838651E+07 1.0258373114606519E+02 1.6090916654357547E+08 1.3053306043515530E+08 4.0730280654315972E+25 5.8855984965091622E+17 9.2001267925480845E-01 0.0000000000000000E+00 1.3714285714494016E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0940738975481816E-20 4.9999999997337063E-01 0.0000000000000000E+00 4.9999999998252359E-01 4.3935976757521474E-11 1.6972747401686740E-13 2.2715191258760565E-17 5.8625490550607648E-24 8.7511653158860796E-32 2.5470045781602842E-41 1.2775629809232235E-52 6.5460309797704803E-66 1.8980383227319182E-80 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 149: 2.2281902373173027E+33 9.9353923737024084E+07 1.0344661184670252E+02 1.5377331495711568E+08 1.2981703269227083E+08 3.8289085733317627E+25 5.7719505950954854E+17 9.2087302690761075E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.3415552179568506E-26 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.6896969792486142E-25 9.2176473837402701E-61 3.5802107752067443E-55 4.9079131690828651E-56 7.6799743677480240E-95 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 150: 2.2472043584656280E+33 1.0038685645822351E+08 1.0431200122863193E+02 1.4686455493665504E+08 1.2910249358359088E+08 3.5963086996417695E+25 5.6586748100034733E+17 9.2176635551007735E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0250563609778702E-26 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 1.0217696709107091E-25 2.3439791854962670E-61 1.6316704846385708E-55 2.2451785797992545E-56 1.3609096406695432E-95 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 151: 2.2659246744334769E+33 1.0143054739792837E+08 1.0518023894176140E+02 1.4017491022440514E+08 1.2838914756257312E+08 3.3747141881650032E+25 5.5457163752078771E+17 9.2269552389504761E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2218757611038818E-26 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 6.1542441451411986E-26 5.9456202369191321E-62 7.3917789127980186E-56 1.0211558993287581E-56 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 152: 2.2843565982992821E+33 1.0248588558871545E+08 1.0605167060788177E+02 1.3369673816024669E+08 1.2767667943431267E+08 3.1636369673375243E+25 5.4330186473940909E+17 9.2366364584948990E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.3385655419760612E-27 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 3.6909214297823555E-26 1.5022323999291633E-62 3.3269404995635901E-56 4.6154537935936356E-57 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 153: 2.3025054326349690E+33 1.0355382415362316E+08 1.0692664802124244E+02 1.2742271252168129E+08 1.2696475082784599E+08 2.9626136922768623E+25 5.3205227970365549E+17 9.2467412234125590E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3859619286773154E-27 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.2033442200067757E-26 3.7747905686090627E-63 1.4869266993049114E-56 2.0720236742325015E-57 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 154: 2.3203763719536581E+33 1.0463538854230312E+08 1.0780552916393762E+02 1.2134580731699774E+08 1.2625299676159099E+08 2.7712043853950578E+25 5.2081674608261786E+17 9.2573067901259654E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6076272675095702E-27 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3087394957503077E-26 9.4173692224675169E-64 6.5952472263051121E-57 9.2340054731585967E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 155: 2.3379745050994525E+33 1.0573168600668678E+08 1.0868867797458788E+02 1.1545928143268691E+08 1.2554102724956098E+08 2.5889911686868245E+25 5.0958883482997069E+17 9.2683741191341951E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5416735238860796E-27 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 7.7315917049085925E-27 2.3284734845210946E-64 2.9013240570243718E-57 4.0825997951706961E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 156: 2.3553048175807600E+33 1.0684391654673727E+08 1.0957646378756380E+02 1.0975666550213240E+08 1.2482785729194163E+08 2.4155770814873518E+25 4.9836177566511533E+17 9.2799861740408829E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.0582792397035085E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 4.5399909349403638E-27 5.6924278018227282E-65 1.2646098804765865E-57 1.7890225274443938E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 157: 2.3723721938485611E+33 1.0797338564843178E+08 1.1046926032203905E+02 1.0423174713184828E+08 1.2411219083743580E+08 2.2505849780577604E+25 4.8712840732543424E+17 9.2921890701735377E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.2854351707551197E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.6477368817903823E-27 1.3722962451406694E-65 5.4548663456631546E-58 7.7608471798962976E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 158: 2.3891814195209998E+33 1.0912151920527849E+08 1.1136744407417976E+02 9.8878555699155778E+07 1.2339320966554609E+08 2.0936565001043570E+25 4.7588112310815987E+17 9.3050359267068494E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0606783996488808E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.5326353936214632E-27 3.2547155519656940E-66 2.3261082420192966E-58 3.3295059409147633E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 159: 2.4057371835556315E+33 1.1028988106781580E+08 1.1227139188617893E+02 9.3691350655391216E+07 1.2267022097628100E+08 1.9444511199906671E+25 4.6461179942768454E+17 9.3185867057394345E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7578121777241827E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 8.7994400085538367E-28 7.5770971820701785E-67 9.7958817765760680E-59 1.4112078572263658E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 160: 2.4220440803706373E+33 1.1148019382055575E+08 1.1318147740341547E+02 8.8664609815817773E+07 1.2194243980927145E+08 1.8026452507799006E+25 4.5331171335078816E+17 9.3329084079732816E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0005148886939879E-28 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 5.0072049348295406E-28 1.7272646713021916E-67 4.0692898531522633E-59 5.9027111324326642E-60 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 161: 2.4381066119162685E+33 1.1269436355249475E+08 1.1409806600708067E+02 8.3793017503728941E+07 1.2120895885208058E+08 1.6679314198505095E+25 4.4197144676491002E+17 9.3480761431502035E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.6390238159660255E-29 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.8215483497423242E-28 3.8453206117352190E-68 1.6652513645528470E-59 2.4333405170271684E-60 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 162: 2.4539291896977627E+33 1.1393450960151790E+08 1.1502150765220883E+02 7.9071452922603711E+07 1.2046871965769587E+08 1.5400175034609533E+25 4.3058077253730445E+17 9.3641744462791920E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.1440693565248875E-29 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 1.5729162990299760E-28 8.3360484357388884E-69 6.7029852570158476E-60 9.8719976401806051E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 163: 2.4695161367509312E+33 1.1520300054718879E+08 1.1595212680506357E+02 7.4494978646118760E+07 1.1972047730220315E+08 1.4186260202711324E+25 4.1912851815987245E+17 9.3812988710134504E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7322120296465111E-29 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 8.6648111719083673E-29 1.7540094389237227E-69 2.6492565355194779E-60 3.9347662855774473E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 164: 2.4848716895715934E+33 1.1650249812716776E+08 1.1689020833260375E+02 7.0058829074927881E+07 1.1896275593794754E+08 1.3034934825393879E+25 4.0760240106276531E+17 9.3995579315007438E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.4181137702383151E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 4.7106223951442682E-29 3.5690451365396981E-70 1.0260378406228845E-60 1.5377450865095252E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 165: 2.4999999999999987E+33 1.1783601130527955E+08 1.1783597768554338E+02 6.5758398673384309E+07 1.1819379098116578E+08 1.1943698045220146E+25 3.9598882792882426E+17 9.4190754810023969E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0456371509168947E-30 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 2.5234580754299779E-29 6.9934161185269733E-71 3.8846340490935479E-61 5.8788351392999120E-62 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 166: 2.5149051370613488E+33 1.1920696349269600E+08 1.1878957296546560E+02 6.1589229743155152E+07 1.1741145398194903E+08 1.0910177685800110E+25 3.8427264779608890E+17 9.4399936546817875E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6587098223883479E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3296099296285794E-29 1.3131465276039095E-71 1.4336988673904135E-61 2.1925169144081270E-62 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 167: 2.5299552941601440E+33 1.2065513621964423E+08 1.1977512756139305E+02 5.7496612352795251E+07 1.1660279530787571E+08 9.9200876977880826E+24 3.7228613157812800E+17 9.4627711126829650E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3632746622552309E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 6.8173509560398531E-30 2.2974171722513527E-72 5.0728914163374141E-62 7.8470303537730089E-63 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 168: 2.5455295344943751E+33 1.2222938110376306E+08 1.2081961001863465E+02 5.3380048535046391E+07 1.1574209642911196E+08 8.9498388932421555E+24 3.5968837558607366E+17 9.4883325162122245E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.6564950346846963E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 3.3285967847764123E-30 3.5390029587693510E-73 1.6638352220983327E-62 2.6070168187732265E-63 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 169: 2.5620467932126522E+33 1.2399418262677610E+08 1.2195499635217722E+02 4.9138915385469355E+07 1.1479657111637495E+08 7.9785427420794509E+24 3.4607090100346483E+17 9.5179925425149869E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0092527324944166E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.5047380467345011E-30 4.4605527281869653E-74 4.8423064357297134E-63 7.7013839615088051E-64 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 170: 2.5799999999999987E+33 1.2604067996226400E+08 1.2322086703848011E+02 4.4665288659901261E+07 1.1372057407047528E+08 6.9869920091973982E+24 3.3090615664860621E+17 9.5537329715996355E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2108657328679868E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 6.0546306858334019E-31 4.1503464316092093E-75 1.1760986268729588E-63 1.9044050177385676E-64 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 171: 2.5999999999999986E+33 1.2850700640734483E+08 1.2466700082215370E+02 3.9836178095964037E+07 1.1244448854664350E+08 5.9572908366453506E+24 3.1346275678280634E+17 9.5987389576045989E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0836619515412620E-32 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.0418943430276805E-31 2.4372535373915109E-76 2.1709450282313532E-64 3.5952877923215598E-65 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 172: 2.6199999999999985E+33 1.3121373813891217E+08 1.2614235345035462E+02 3.4866303592007339E+07 1.1096672868131287E+08 4.9452172594575132E+24 2.9412191830747117E+17 9.6540787235087999E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1527986311975165E-32 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 5.7640961402328062E-32 9.0043145097986942E-78 3.0383501649520258E-65 5.1713558262689456E-66 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 173: 2.6399999999999984E+33 1.3422468093333033E+08 1.2762637210022150E+02 3.0007611466154538E+07 1.0929216469517799E+08 4.0069425206958003E+24 2.7354324680432234E+17 9.7199975195479882E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7488297196796970E-33 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3744280060794202E-32 2.1441305794077077E-79 3.2670076316838852E-66 5.7410737339100436E-67 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 174: 2.6599999999999983E+33 1.3763513915637383E+08 1.2907260546711365E+02 2.5255417772623468E+07 1.0732289158834216E+08 3.1435259657843108E+24 2.5139945173121638E+17 9.8000665613941906E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.1406245784144671E-34 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.5703241595253569E-33 2.7151966625606077E-81 2.4006744606659146E-67 4.3801711277929650E-68 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 175: 2.6799999999999983E+33 1.4159806173575488E+08 1.3037159276381720E+02 2.0601615071272954E+07 1.0487883390178445E+08 2.3566427223754949E+24 2.2719172604447981E+17 9.8998115968761691E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.5861934595818810E-35 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 3.2931029983723101E-34 1.2887399507192005E-83 9.7319217814289036E-69 1.8561841259521894E-69 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 176: 2.6999999999999982E+33 1.4638594432043806E+08 1.3123568318919655E+02 1.6030972965060076E+07 1.0158907392969932E+08 1.6489389255810598E+24 2.0009028465021510E+17 1.0028391194083799E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3682041046040385E-36 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.1841033599938810E-35 1.1117404992749742E-86 1.3943855845406180E-70 2.8019089438174828E-71 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 177: 2.7199999999999981E+33 1.5257299456718874E+08 1.3072970848543858E+02 1.1510956039807228E+07 9.6547800681927606E+07 1.0247555241962731E+24 1.6851265358498282E+17 1.0202486915058262E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 178: 2.7399999999999980E+33 1.6183242814039430E+08 1.2404730267916084E+02 6.9532861871898444E+06 8.6590809931079119E+07 4.9190648194242471E+23 1.2857972416359624E+17 1.0453300045083935E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
diff --git a/Util/initial_models/kepler_hybrid/kepler_new_6.25e8.raw b/Util/initial_models/kepler_hybrid/kepler_new_6.25e8.raw
deleted file mode 100644
index 100db714a..000000000
--- a/Util/initial_models/kepler_hybrid/kepler_new_6.25e8.raw
+++ /dev/null
@@ -1,186 +0,0 @@
-# npts = 178
-# num of variables = 6
-# density
-# temperature
-# pressure
-# carbon-12
-# oxygen-16
-# ash
-2.0831459844146401E+06 2.6409019248480692E+09 6.2496973682955909E+08 1.7729710406238415E+27 4.9695993464355021E-01 4.9800451975916810E-01 0.00503554
-2.8099754690829176E+06 2.6370595885716796E+09 6.2442569729721022E+08 1.7695149825654912E+27 4.9696001384214056E-01 4.9800457200591092E-01 0.00503541
-3.4235596900334051E+06 2.6330758682181296E+09 6.2386108185022426E+08 1.7659335465012540E+27 4.9696011242928001E-01 4.9800463704223519E-01 0.00503525
-3.9812761894107144E+06 2.6287805416016064E+09 6.2325174344542372E+08 1.7620740188396826E+27 4.9696023203523665E-01 4.9800471594313511E-01 0.00503505
-4.4938259837549161E+06 2.6242204473153596E+09 6.2260425662937510E+08 1.7579789155647876E+27 4.9696037065249410E-01 4.9800480738379616E-01 0.00503482
-4.9596415520723276E+06 2.6195309990321012E+09 6.2193777500890696E+08 1.7537701531026699E+27 4.9696052197272722E-01 4.9800490720243051E-01 0.00503457
-5.3949069858569233E+06 2.6147606573500462E+09 6.2125917806081617E+08 1.7494913986408206E+27 4.9696068367768920E-01 4.9800501386952517E-01 0.0050343
-5.8082034809508231E+06 2.6098786448427224E+09 6.2056407197471702E+08 1.7451152098515370E+27 4.9696085620158176E-01 4.9800512767121713E-01 0.00503401
-6.2043999919881672E+06 2.6048731602821755E+09 6.1985074737197852E+08 1.7406312117236775E+27 4.9696103952706916E-01 4.9800524859576983E-01 0.00503371
-6.5863214199832808E+06 2.5997443508872347E+09 6.1911919034092629E+08 1.7360397551590964E+27 4.9696123329207226E-01 4.9800537640404224E-01 0.00503339
-6.9555725852980549E+06 2.5945007852521968E+09 6.1837058717043614E+08 1.7313487279661635E+27 4.9696143684266314E-01 4.9800551066439880E-01 0.00503305
-7.3129897723894808E+06 2.5891573976009822E+09 6.1760703646588480E+08 1.7265716913770020E+27 4.9696164926846365E-01 4.9800565077607789E-01 0.0050327
-7.6589093041779017E+06 2.5837341042075725E+09 6.1683135578828120E+08 1.7217266230979776E+27 4.9696186943387610E-01 4.9800579598980860E-01 0.00503233
-7.9933384883839739E+06 2.5782547400988431E+09 6.1604693304540312E+08 1.7168349507082851E+27 4.9696209601007557E-01 4.9800594542892812E-01 0.00503196
-8.3160708624541750E+06 2.5727461503645935E+09 6.1525759914548361E+08 1.7119207268721032E+27 4.9696232750986935E-01 4.9800609811238772E-01 0.00503157
-8.6267677704250254E+06 2.5672373566210032E+09 6.1446751060123253E+08 1.7070098753787488E+27 4.9696256232534930E-01 4.9800625297959689E-01 0.00503118
-8.9250184814981632E+06 2.5617587626731563E+09 6.1368103694797730E+08 1.7021294760471829E+27 4.9696279876791294E-01 4.9800640891682674E-01 0.00503079
-9.2103859051398840E+06 2.5563413868601093E+09 6.1290265118090105E+08 1.6973070774419289E+27 4.9696303510950951E-01 4.9800656478441607E-01 0.0050304
-9.4824421144839823E+06 2.5510161217167950E+09 6.1213682331581128E+08 1.6925700379644354E+27 4.9696326962374837E-01 4.9800671944388308E-01 0.00503001
-9.7407962575145904E+06 2.5458130289649572E+09 6.1138791826737702E+08 1.6879449022904994E+27 4.9696350062570710E-01 4.9800687178417452E-01 0.00502962
-9.9851164689896442E+06 2.5407606816886115E+09 6.1066009982076001E+08 1.6834568233558619E+27 4.9696372650906351E-01 4.9800702074614650E-01 0.00502925
-1.0220882509282932E+07 2.5358238597635822E+09 6.0994834268667495E+08 1.6790742798836187E+27 4.9696394855937487E-01 4.9800716717777888E-01 0.00502888
-1.0452769122143012E+07 2.5309111483029213E+09 6.0923949219064009E+08 1.6747160014011120E+27 4.9696417069039323E-01 4.9800731366009238E-01 0.00502851
-1.0685008758771149E+07 2.5259351440570264E+09 6.0852093040311766E+08 1.6703044868775219E+27 4.9696439673606163E-01 4.9800746272129842E-01 0.00502814
-1.0921665557921387E+07 2.5208073402275629E+09 6.0777983857381439E+08 1.6657614652723174E+27 4.9696463065629221E-01 4.9800761697249646E-01 0.00502775
-1.1166863152942896E+07 2.5154332798899078E+09 6.0700249288453829E+08 1.6610036215656713E+27 4.9696487674209278E-01 4.9800777924291878E-01 0.00502734
-1.1424993597828886E+07 2.5097074804259510E+09 6.0617352114718521E+08 1.6559381499142370E+27 4.9696513983799362E-01 4.9800795272655840E-01 0.0050269
-1.1700926818906905E+07 2.5035076712810884E+09 6.0527505267271566E+08 1.6504577367749998E+27 4.9696542559939888E-01 4.9800814115179493E-01 0.00502643
-1.2000236001008619E+07 2.4966878592779088E+09 6.0428568799971592E+08 1.6444345594127063E+27 4.9696574080397732E-01 4.9800834898661006E-01 0.00502591
-1.2329452470956011E+07 2.4890696510369782E+09 6.0317920075379503E+08 1.6377128211369062E+27 4.9696609373890832E-01 4.9800858169375772E-01 0.00502532
-1.2696363050641827E+07 2.4804311206237745E+09 6.0192286004243255E+08 1.6300992365553876E+27 4.9696649468967802E-01 4.9800884605279977E-01 0.00502466
-1.3100136267390139E+07 2.4706299719529266E+09 6.0049529454451132E+08 1.6214718244683059E+27 4.9696695014105075E-01 4.9800914633638099E-01 0.0050239
-1.3539159681880834E+07 2.4596313676227870E+09 5.9889060003246772E+08 1.6118041261423293E+27 4.9696746139771009E-01 4.9800948340118206E-01 0.00502305
-1.4011130304633314E+07 2.4474200131921520E+09 5.9710558873421407E+08 1.6010875372337645E+27 4.9696802859740474E-01 4.9800985733409525E-01 0.00502211
-1.4513168023087824E+07 2.4340012979947305E+09 5.9513997484128082E+08 1.5893322074188608E+27 4.9696865063089468E-01 4.9801026739961152E-01 0.00502108
-1.5041937279142816E+07 2.4194017661453519E+09 5.9299647203577387E+08 1.5765673001634111E+27 4.9696932512337788E-01 4.9801071202779490E-01 0.00501996
-1.5593765398859266E+07 2.4036689752759976E+09 5.9068081069940794E+08 1.5628406676609305E+27 4.9697004847888238E-01 4.9801118884380602E-01 0.00501876
-1.6164750113713734E+07 2.3868708068630533E+09 5.8820168279333901E+08 1.5482180049716492E+27 4.9697081598364368E-01 4.9801169473632906E-01 0.00501749
-1.6750852735022031E+07 2.3690942870776439E+09 5.8557062112554431E+08 1.5327815461634159E+27 4.9697162195954592E-01 4.9801222595899453E-01 0.00501615
-1.7347976467814416E+07 2.3504439693609910E+09 5.8280181809819245E+08 1.5166283610897120E+27 4.9697245995512351E-01 4.9801277825652740E-01 0.00501476
-1.7952031276405588E+07 2.3310399250564766E+09 5.7991188789664078E+08 1.4998683091307458E+27 4.9697332295944574E-01 4.9801334700592276E-01 0.00501333
-1.8558987656311277E+07 2.3110153887935238E+09 5.7691957584281242E+08 1.4826217076391268E+27 4.9697420362385281E-01 4.9801392736272071E-01 0.00501187
-1.9164921880954050E+07 2.2905141107093859E+09 5.7384541929472542E+08 1.4650167775844564E+27 4.9697509447775179E-01 4.9801451440328309E-01 0.00501039
-1.9766055046513844E+07 2.2696874763059478E+09 5.7071136583862925E+08 1.4471869353411932E+27 4.9697598812711818E-01 4.9801510325558684E-01 0.00500891
-2.0358787755603854E+07 2.2486914645236111E+09 5.6754035627847302E+08 1.4292680057091321E+27 4.9697687742781477E-01 4.9801568921334527E-01 0.00500743
-2.0939731715360809E+07 2.2276835233559413E+09 5.6435588177123129E+08 1.4113954353410165E+27 4.9697775562908086E-01 4.9801626783041025E-01 0.00500597
-2.1505738974040221E+07 2.2068194483685617E+09 5.6118152613402104E+08 1.3937015865616156E+27 4.9697861648599023E-01 4.9801683499468474E-01 0.00500455
-2.2053929034890752E+07 2.1862503517803936E+09 5.5804050562618744E+08 1.3763131885344260E+27 4.9697945434213642E-01 4.9801738698239501E-01 0.00500316
-2.2581713691725142E+07 2.1661198078509035E+09 5.5495521926679993E+08 1.3593490158877171E+27 4.9698026418561991E-01 4.9801792049476917E-01 0.00500181
-2.3086819136037227E+07 2.1465612542510900E+09 5.5194682289420664E+08 1.3429178547546855E+27 4.9698104168223078E-01 4.9801843267970464E-01 0.00500052
-2.3567304691261414E+07 2.1276957193268297E+09 5.4903483967417216E+08 1.3271168035319405E+27 4.9698178318996367E-01 4.9801892114116009E-01 0.00499929
-2.4026918777306151E+07 2.1095233176394558E+09 5.4622027769201362E+08 1.3119410360509305E+27 4.9698248993438554E-01 4.9801938668942353E-01 0.00499812
-2.4468846153731428E+07 2.0919421902317359E+09 5.4348825587376344E+08 1.2973010664269471E+27 4.9698316690583932E-01 4.9801983261418076E-01 0.004997
-2.4895832760556966E+07 2.0748623840656188E+09 5.4082553093418908E+08 1.2831183522906475E+27 4.9698381841989459E-01 4.9802026176008080E-01 0.00499592
-2.5310279397997320E+07 2.0582034800053203E+09 5.3822016444889843E+08 1.2693231406417898E+27 4.9698444825131005E-01 4.9802067661510935E-01 0.00499487
-2.5714313498339538E+07 2.0418927225048480E+09 5.3566125875325412E+08 1.2558527768638181E+27 4.9698505973872265E-01 4.9802107937964474E-01 0.00499386
-2.6109845193762172E+07 2.0258635164368234E+09 5.3313874302508688E+08 1.2426503534005818E+27 4.9698565586783083E-01 4.9802147202132285E-01 0.00499287
-2.6498611943291198E+07 2.0100541966634853E+09 5.3064319644531661E+08 1.2296636115606800E+27 4.9698623933837383E-01 4.9802185631921131E-01 0.0049919
-2.6882214715270709E+07 1.9944070026037996E+09 5.2816569899883705E+08 1.2168440344826943E+27 4.9698681261878719E-01 4.9802223389985234E-01 0.00499095
-2.7262147876103647E+07 1.9788672081448488E+09 5.2569770296275210E+08 1.2041460860071824E+27 4.9698737799170312E-01 4.9802260626726524E-01 0.00499001
-2.7639824360503513E+07 1.9633823697776842E+09 5.2323091983407491E+08 1.1915265618092412E+27 4.9698793759204790E-01 4.9802297482806590E-01 0.00498908
-2.8016597300290573E+07 1.9479016646708412E+09 5.2075721865038800E+08 1.1789440273622244E+27 4.9698849343974644E-01 4.9802334091302775E-01 0.00498816
-2.8393779009510756E+07 1.9323752967185204E+09 5.1826853250052726E+08 1.1663583232230684E+27 4.9698904746812667E-01 4.9802370579580635E-01 0.00498724
-2.8772658025890525E+07 1.9167539531876664E+09 5.1575677062237072E+08 1.1537301224664501E+27 4.9698960154893479E-01 4.9802407070942822E-01 0.00498633
-2.9154514767882694E+07 1.9009882979543271E+09 5.1321373392065501E+08 1.1410205283258323E+27 4.9699015751505793E-01 4.9802443686126729E-01 0.0049854
-2.9540636267970141E+07 1.8850284828929534E+09 5.1063143780903077E+08 1.1281907025555474E+27 4.9699073560435175E-01 4.9802481757980521E-01 0.00498444
-2.9932330365827333E+07 1.8688237024277344E+09 5.0800081673673368E+08 1.1152015169291472E+27 4.9699131948552389E-01 4.9802520210963847E-01 0.00498348
-3.0330939711359646E+07 1.8523217136684444E+09 5.0531285101095176E+08 1.1020132218025124E+27 4.9699191119113839E-01 4.9802559178951133E-01 0.00498249
-3.0737855883919880E+07 1.8354683845700364E+09 5.0255807020963782E+08 1.0885851269333353E+27 4.9699251260790678E-01 4.9802598786207858E-01 0.0049815
-3.1154533925828133E+07 1.8182072287950594E+09 4.9972646623266828E+08 1.0748752908283262E+27 4.9699312574662552E-01 4.9802639165168366E-01 0.00498048
-3.1582507584398247E+07 1.8004789290015879E+09 4.9680739378155744E+08 1.0608402158841759E+27 4.9699375269890661E-01 4.9802680453586584E-01 0.00497944
-3.2023405566138491E+07 1.7822208435023196E+09 4.9378946478609496E+08 1.0464345475620380E+27 4.9699439565718140E-01 4.9802722795853677E-01 0.00497837
-3.2478969128185980E+07 1.7633664919909556E+09 4.9066043392317361E+08 1.0316107768488108E+27 4.9699505693586321E-01 4.9802766344391963E-01 0.00497728
-3.2951071366304226E+07 1.7438450166309175E+09 4.8740707359298670E+08 1.0163189463808209E+27 4.9699573899379179E-01 4.9802811261133240E-01 0.00497615
-3.3441738607751362E+07 1.7235806155111001E+09 4.8401503660292262E+08 1.0005063619040640E+27 4.9699644445855218E-01 4.9802857719120402E-01 0.00497498
-3.3953174383919500E+07 1.7024919463438284E+09 4.8046870464867693E+08 9.8411731230069222E+26 4.9699717615298883E-01 4.9802905904253691E-01 0.00497376
-3.4485286719666719E+07 1.6805451176495612E+09 4.7676010413844275E+08 9.6713420321123733E+26 4.9699793525045555E-01 4.9802955893806772E-01 0.0049725
-3.5037937686749451E+07 1.6577566079506781E+09 4.7288956786104649E+08 9.4957910114568826E+26 4.9699872124907973E-01 4.9803007654734388E-01 0.0049712
-3.5610946577242859E+07 1.6341468677709448E+09 4.6885799982266504E+08 9.3147738345208012E+26 4.9699953357863402E-01 4.9803061149491612E-01 0.00496985
-3.6204093169448510E+07 1.6097402495970304E+09 4.6466687947662443E+08 9.1285760258192747E+26 4.9700037161261978E-01 4.9803116336829140E-01 0.00496846
-3.6817121000756919E+07 1.5845649059336643E+09 4.6031826270787317E+08 8.9375131898980863E+26 4.9700123469051483E-01 4.9803173173257920E-01 0.00496703
-3.7449740571499579E+07 1.5586526570680599E+09 4.5581478007309294E+08 8.7419290496788268E+26 4.9700212216683304E-01 4.9803231616279442E-01 0.00496556
-3.8101632414616406E+07 1.5320388303729000E+09 4.5115963350416195E+08 8.5421932201249229E+26 4.9700303353553166E-01 4.9803291632577867E-01 0.00496405
-3.8772449977328286E+07 1.5047620731222658E+09 4.4635659491864073E+08 8.3386987456042136E+26 4.9700396878063646E-01 4.9803353221109325E-01 0.0049625
-3.9461822272412568E+07 1.4768641408284252E+09 4.4141001817746955E+08 8.1318594312568705E+26 4.9700492948192904E-01 4.9803416485913943E-01 0.0049609
-4.0169356267858386E+07 1.4483896627687852E+09 4.3632490963239098E+08 7.9221070001707174E+26 4.9700592291533391E-01 4.9803481906136565E-01 0.00495926
-4.0894638995428950E+07 1.4193858839130218E+09 4.3110729305056006E+08 7.7098881092704695E+26 4.9700698290791656E-01 4.9803551709380423E-01 0.0049575
-4.1637239348558068E+07 1.3899024232104537E+09 4.2576258482524127E+08 7.4956612576102524E+26 4.9700806461795133E-01 4.9803622942703601E-01 0.0049557
-4.2396709596242838E+07 1.3599909536516910E+09 4.2027678387662745E+08 7.2798936207000530E+26 4.9700917117061383E-01 4.9803695811909537E-01 0.00495387
-4.3172586591128252E+07 1.3297049190628486E+09 4.1469609262193966E+08 7.0630578454462204E+26 4.9701030439950145E-01 4.9803770437746581E-01 0.00495199
-4.3964392661268875E+07 1.2990992684067252E+09 4.0900459250132787E+08 6.8456288391303573E+26 4.9701131743390436E-01 4.9803837148434815E-01 0.00495031
-4.4771636295144081E+07 1.2682300176762495E+09 4.0321338254552013E+08 6.6280805852657209E+26 4.9701235166719976E-01 4.9803905255066949E-01 0.00494859
-4.5593812489771597E+07 1.2371540567078078E+09 3.9733040043757504E+08 6.4108830199437674E+26 4.9701340636483898E-01 4.9803974709270638E-01 0.00494684
-4.6430402875631697E+07 1.2059287876918533E+09 3.9136391101358134E+08 6.1944989982132472E+26 4.9701448073068427E-01 4.9804045458617180E-01 0.00494506
-4.7280875614325613E+07 1.1746118062808378E+09 3.8532247211657178E+08 5.9793813803254457E+26 4.9701557390779549E-01 4.9804117446673468E-01 0.00494325
-4.8144685089927301E+07 1.1432605861267288E+09 3.7921489900186396E+08 5.7659702653067932E+26 4.9701668497926754E-01 4.9804190613057203E-01 0.00494141
-4.9021311850933582E+07 1.1119314322735040E+09 3.7305008165757328E+08 5.5546854496172979E+26 4.9701781299638137E-01 4.9804264895290851E-01 0.00493954
-4.9910222981137879E+07 1.0806792473918674E+09 3.6683695270827264E+08 5.3459247146446549E+26 4.9701895697862691E-01 4.9804340228803146E-01 0.00493764
-5.0810871284311064E+07 1.0495579679782509E+09 3.6058458769816476E+08 5.1400666525454341E+26 4.9702011589026573E-01 4.9804416545385843E-01 0.00493572
-5.1722694355371252E+07 1.0186203000994186E+09 3.5430216792786658E+08 4.9374687940164546E+26 4.9702128864115380E-01 4.9804493773247915E-01 0.00493377
-5.2645113558241323E+07 9.8791746887080920E+08 3.4799894279876149E+08 4.7384659653368278E+26 4.9702247408748212E-01 4.9804571837064393E-01 0.0049318
-5.3577532930703938E+07 9.5749898346146369E+08 3.4168419188071185E+08 4.5433688847563005E+26 4.9702367103258716E-01 4.9804650658029787E-01 0.00492982
-5.4519338036760658E+07 9.2741241924931347E+08 3.3536718692220312E+08 4.3524630051846033E+26 4.9702487822755115E-01 4.9804730153897675E-01 0.00492782
-5.5469894787313811E+07 8.9770321856230819E+08 3.2905715404049712E+08 4.1660076069719166E+26 4.9702609437196860E-01 4.9804810239031205E-01 0.0049258
-5.6428548250437431E+07 8.6841451123473847E+08 3.2276323632359159E+08 3.9842351414056173E+26 4.9702731811457984E-01 4.9804890824444858E-01 0.00492377
-5.7394621473092191E+07 8.3958695599068165E+08 3.1649445708922982E+08 3.8073508224641773E+26 4.9702854805410257E-01 4.9804971817859256E-01 0.00492173
-5.8367414336870909E+07 8.1125860343588054E+08 3.1025968403723615E+08 3.6355324613817045E+26 4.9702978274004589E-01 4.9805053123754894E-01 0.00491968
-5.9346202471223228E+07 7.8346478120269775E+08 3.0406759453970474E+08 3.4689305357626556E+26 4.9703102067380001E-01 4.9805134643443899E-01 0.00491763
-6.0330236248581715E+07 7.5623800155265415E+08 2.9792664229926521E+08 3.3076684823817375E+26 4.9703226030991665E-01 4.9805216275154474E-01 0.00491557
-6.1318739886868507E+07 7.2960789149957240E+08 2.9184502560347176E+08 3.1518432004420141E+26 4.9703350005768310E-01 4.9805297914134583E-01 0.00491352
-6.2310910685963027E+07 7.0360114528042650E+08 2.8583065739141309E+08 3.0015257499975518E+26 4.9703473828310774E-01 4.9805379452782711E-01 0.00491146
-6.3305918425810508E+07 6.7824149877028871E+08 2.7989113733219445E+08 2.8567622284794911E+26 4.9703597331131216E-01 4.9805460780805433E-01 0.00490942
-6.4302904954889834E+07 6.5354972521973729E+08 2.7403372610148650E+08 2.7175748068408207E+26 4.9703720342944557E-01 4.9805541785409285E-01 0.00490738
-6.5300983998671211E+07 6.2954365148723602E+08 2.6826532202063689E+08 2.5839629057456150E+26 4.9703842689021149E-01 4.9805622351533052E-01 0.00490535
-6.6299241218400948E+07 6.0623819375122285E+08 2.6259244020106080E+08 2.4559044914957195E+26 4.9703964191600847E-01 4.9805702362120435E-01 0.00490333
-6.7296734550965875E+07 5.8364541151744258E+08 2.5702119431097120E+08 2.3333574709974392E+26 4.9704084670380810E-01 4.9805781698441304E-01 0.00490133
-6.8292494860617250E+07 5.6177457858917141E+08 2.5155728105780628E+08 2.2162611650163229E+26 4.9704203943080488E-01 4.9805860240463717E-01 0.00489936
-6.9285526932869360E+07 5.4063226954356480E+08 2.4620596744602606E+08 2.1045378392359373E+26 4.9704321826082543E-01 4.9805937867276034E-01 0.0048974
-7.0274810839821845E+07 5.2022246015647346E+08 2.4097208084623453E+08 1.9980942731980592E+26 4.9704438135164147E-01 4.9806014457568437E-01 0.00489547
-7.1259303704375118E+07 5.0054664014229721E+08 2.3586000187741524E+08 1.8968233480340057E+26 4.9704552686315606E-01 4.9806089890172034E-01 0.00489357
-7.2237941888202056E+07 4.8160393652478701E+08 2.3087366007204750E+08 1.8006056349673307E+26 4.9704665296636513E-01 4.9806164044648954E-01 0.0048917
-7.3211324387764260E+07 4.6337563302460331E+08 2.2601233839986527E+08 1.7092332249946879E+26 4.9704775883114105E-01 4.9806236866338338E-01 0.00488987
-7.4180024200858131E+07 4.4582829884121293E+08 2.2127121339405793E+08 1.6224310655354588E+26 4.9704884449998110E-01 4.9806308358042173E-01 0.00488807
-7.5144591748626828E+07 4.2893053935513943E+08 2.1664570571238896E+08 1.5399429159809291E+26 4.9704990993377163E-01 4.9806378517188354E-01 0.0048863
-7.6105557972005397E+07 4.1265283459791690E+08 2.1213146048478055E+08 1.4615297718244693E+26 4.9705095500979662E-01 4.9806447335699577E-01 0.00488457
-7.7063437154736668E+07 3.9696739401352251E+08 2.0772432960699528E+08 1.3869684503471491E+26 4.9705197951870450E-01 4.9806514799793600E-01 0.00488287
-7.8018729517595947E+07 3.8184802550323743E+08 2.0342035572933066E+08 1.3160503179799679E+26 4.9705298316031099E-01 4.9806580889706908E-01 0.00488121
-7.8971923622409120E+07 3.6727001703623736E+08 1.9921575772556305E+08 1.2485801423235157E+26 4.9705396553803838E-01 4.9806645579328535E-01 0.00487958
-7.9923498619569466E+07 3.5321002935210931E+08 1.9510691745944732E+08 1.1843750542032427E+26 4.9705492615192581E-01 4.9806708835739821E-01 0.00487798
-8.0873926368846312E+07 3.3964599848464459E+08 1.9109036769048470E+08 1.1232636071444771E+26 4.9705586438989247E-01 4.9806770618639140E-01 0.00487643
-8.1823673460172027E+07 3.2655704700788933E+08 1.8716278098272657E+08 1.0650849233455407E+26 4.9705677951697619E-01 4.9806830879633246E-01 0.00487491
-8.2773203158667594E+07 3.1392340305033743E+08 1.8332095949834388E+08 1.0096879166605810E+26 4.9705767066211792E-01 4.9806889561367079E-01 0.00487343
-8.3722977296326175E+07 3.0172632624644893E+08 1.7956182557692003E+08 9.5693058432335779E+25 4.9705853680202666E-01 4.9806946596461288E-01 0.00487199
-8.4673458131449208E+07 2.8994803989892286E+08 1.7588241300959209E+08 9.0667936018010543E+25 4.9705937674121214E-01 4.9807001906197429E-01 0.0048706
-8.5625110196067065E+07 2.7857166871552330E+08 1.7227985893883061E+08 8.5880852309310880E+25 4.9706018908739735E-01 4.9807055398898886E-01 0.00486925
-8.6578402151145890E+07 2.6758118156027406E+08 1.6875139632152340E+08 8.1319965493748296E+25 4.9706097222069545E-01 4.9807106967901238E-01 0.00486796
-8.7533808669360712E+07 2.5696133872597349E+08 1.6529434691446930E+08 7.6974114327723746E+25 4.9706172425477835E-01 4.9807156488995219E-01 0.00486671
-8.8491812365603536E+07 2.4669764329110608E+08 1.6190611475507718E+08 7.2832772437254396E+25 4.9706244298687408E-01 4.9807203817134138E-01 0.00486552
-8.9452905796197221E+07 2.3677629617451167E+08 1.5858418014474282E+08 6.8886006266851931E+25 4.9706312583239753E-01 4.9807248782129326E-01 0.00486438
-9.0417593549030647E+07 2.2718415454340532E+08 1.5532609418493867E+08 6.5124436334350762E+25 4.9706376973715571E-01 4.9807291182868974E-01 0.00486332
-9.1386394448553115E+07 2.1790869326789686E+08 1.5212947400100598E+08 6.1539201487196267E+25 4.9706437105569318E-01 4.9807330779307246E-01 0.00486232
-9.2359843901825547E+07 2.0893796914722133E+08 1.4899199895776245E+08 5.8121925888514683E+25 4.9706492537571445E-01 4.9807367280902670E-01 0.0048614
-9.3338496414701328E+07 2.0026058766029701E+08 1.4591140853708431E+08 5.4864688490086687E+25 4.9706542725065606E-01 4.9807400329008167E-01 0.00486057
-9.4322928310809672E+07 1.9186567201570871E+08 1.4288550346459830E+08 5.1759994774768489E+25 4.9706586976118894E-01 4.9807429467996367E-01 0.00485983
-9.5313740690502569E+07 1.8374283429017201E+08 1.3991215434685385E+08 4.8800750573255915E+25 4.9706624371579899E-01 4.9807454092618386E-01 0.00485921
-9.6311562672611281E+07 1.7588214843382779E+08 1.3698933203654155E+08 4.5980237779860768E+25 4.9706653593022321E-01 4.9807473334706065E-01 0.00485873
-9.7317054969889984E+07 1.6827412476329100E+08 1.3411523114373811E+08 4.3292091809602716E+25 4.9706672419789460E-01 4.9807485731979678E-01 0.00485842
-9.8330917095838651E+07 1.6090916654357547E+08 1.3053306043515530E+08 4.0730280654315972E+25 4.9999999997337063E-01 4.9999999998252359E-01 4.41057e-11
-9.9353923737024084E+07 1.5377331495711568E+08 1.2981703269227083E+08 3.8289085733317627E+25 5.0000000000000000E-01 5.0000000000000000E-01 1.6897e-25
-1.0038685645822351E+08 1.4686455493665504E+08 1.2910249358359088E+08 3.5963086996417695E+25 4.9999999999995770E-01 4.9999999999997180E-01 1.02177e-25
-1.0143054739792837E+08 1.4017491022440514E+08 1.2838914756257312E+08 3.3747141881650032E+25 4.9999999999995770E-01 4.9999999999997180E-01 6.15424e-26
-1.0248588558871545E+08 1.3369673816024669E+08 1.2767667943431267E+08 3.1636369673375243E+25 4.9999999999995770E-01 4.9999999999997180E-01 3.69092e-26
-1.0355382415362316E+08 1.2742271252168129E+08 1.2696475082784599E+08 2.9626136922768623E+25 5.0000000000000000E-01 5.0000000000000000E-01 2.20334e-26
-1.0463538854230312E+08 1.2134580731699774E+08 1.2625299676159099E+08 2.7712043853950578E+25 5.0000000000000000E-01 5.0000000000000000E-01 1.30874e-26
-1.0573168600668678E+08 1.1545928143268691E+08 1.2554102724956098E+08 2.5889911686868245E+25 4.9999999999995770E-01 4.9999999999997180E-01 7.73159e-27
-1.0684391654673727E+08 1.0975666550213240E+08 1.2482785729194163E+08 2.4155770814873518E+25 5.0000000000000000E-01 5.0000000000000000E-01 4.53999e-27
-1.0797338564843178E+08 1.0423174713184828E+08 1.2411219083743580E+08 2.2505849780577604E+25 5.0000000000000000E-01 5.0000000000000000E-01 2.64774e-27
-1.0912151920527849E+08 9.8878555699155778E+07 1.2339320966554609E+08 2.0936565001043570E+25 5.0000000000000000E-01 5.0000000000000000E-01 1.53264e-27
-1.1028988106781580E+08 9.3691350655391216E+07 1.2267022097628100E+08 1.9444511199906671E+25 5.0000000000000000E-01 5.0000000000000000E-01 8.79944e-28
-1.1148019382055575E+08 8.8664609815817773E+07 1.2194243980927145E+08 1.8026452507799006E+25 4.9999999999995770E-01 4.9999999999997180E-01 5.0072e-28
-1.1269436355249475E+08 8.3793017503728941E+07 1.2120895885208058E+08 1.6679314198505095E+25 5.0000000000000000E-01 5.0000000000000000E-01 2.82155e-28
-1.1393450960151790E+08 7.9071452922603711E+07 1.2046871965769587E+08 1.5400175034609533E+25 4.9999999999995770E-01 4.9999999999997180E-01 1.57292e-28
-1.1520300054718879E+08 7.4494978646118760E+07 1.1972047730220315E+08 1.4186260202711324E+25 4.9999999999995770E-01 4.9999999999997180E-01 8.66481e-29
-1.1650249812716776E+08 7.0058829074927881E+07 1.1896275593794754E+08 1.3034934825393879E+25 5.0000000000000000E-01 5.0000000000000000E-01 4.71062e-29
-1.1783601130527955E+08 6.5758398673384309E+07 1.1819379098116578E+08 1.1943698045220146E+25 4.9999999999995770E-01 4.9999999999997180E-01 2.52346e-29
-1.1920696349269600E+08 6.1589229743155152E+07 1.1741145398194903E+08 1.0910177685800110E+25 5.0000000000000000E-01 5.0000000000000000E-01 1.32961e-29
-1.2065513621964423E+08 5.7496612352795251E+07 1.1660279530787571E+08 9.9200876977880826E+24 5.0000000000000000E-01 5.0000000000000000E-01 6.81735e-30
-1.2222938110376306E+08 5.3380048535046391E+07 1.1574209642911196E+08 8.9498388932421555E+24 5.0000000000000000E-01 5.0000000000000000E-01 3.3286e-30
-1.2399418262677610E+08 4.9138915385469355E+07 1.1479657111637495E+08 7.9785427420794509E+24 5.0000000000000000E-01 5.0000000000000000E-01 1.50474e-30
-1.2604067996226400E+08 4.4665288659901261E+07 1.1372057407047528E+08 6.9869920091973982E+24 5.0000000000000000E-01 5.0000000000000000E-01 6.05463e-31
-1.2850700640734483E+08 3.9836178095964037E+07 1.1244448854664350E+08 5.9572908366453506E+24 5.0000000000000000E-01 5.0000000000000000E-01 2.04189e-31
-1.3121373813891217E+08 3.4866303592007339E+07 1.1096672868131287E+08 4.9452172594575132E+24 5.0000000000000000E-01 5.0000000000000000E-01 5.7641e-32
-1.3422468093333033E+08 3.0007611466154538E+07 1.0929216469517799E+08 4.0069425206958003E+24 5.0000000000000000E-01 5.0000000000000000E-01 1.37443e-32
-1.3763513915637383E+08 2.5255417772623468E+07 1.0732289158834216E+08 3.1435259657843108E+24 5.0000000000000000E-01 5.0000000000000000E-01 2.57032e-33
-1.4159806173575488E+08 2.0601615071272954E+07 1.0487883390178445E+08 2.3566427223754949E+24 5.0000000000000000E-01 5.0000000000000000E-01 3.2931e-34
-1.4638594432043806E+08 1.6030972965060076E+07 1.0158907392969932E+08 1.6489389255810598E+24 5.0000000000000000E-01 5.0000000000000000E-01 2.1841e-35
-1.5257299456718874E+08 1.1510956039807228E+07 9.6547800681927606E+07 1.0247555241962731E+24 5.0000000000000000E-01 5.0000000000000000E-01 0
-1.6183242814039430E+08 6.9532861871898444E+06 8.6590809931079119E+07 4.9190648194242471E+23 5.0000000000000000E-01 5.0000000000000000E-01 0
diff --git a/Util/initial_models/kepler_hybrid/kepler_new_6.5e8.dat b/Util/initial_models/kepler_hybrid/kepler_new_6.5e8.dat
deleted file mode 100644
index deabc92f1..000000000
--- a/Util/initial_models/kepler_hybrid/kepler_new_6.5e8.dat
+++ /dev/null
@@ -1,180 +0,0 @@
-# VERSION 10104 -- Thu Aug 27 17:55:27 2009 UTC -- created by woosley on banzai.ucolick.org from file /data/woosley/banzai/u/woosley/cdef/fudgc#t8eq65
- grid cell outer total mass cell outer radius cell outer velocity cell density cell temperature cell pressure cell specific energy cell specific entropy cell angular velocity cell A_bar cell Y_e stability NETWORK neutrons H1 He3 He4 C12 N14 O16 Ne20 Mg24 Si28 S32 Ar36 Ca40 Ti44 Cr48 Fe52 Fe54 Ni56 Fe56 'Fe'
- 1: 9.9999999999607598E+28 2.0931028478783807E+06 1.1368098201492700E+01 2.6033927129099412E+09 6.5000840395404565E+08 1.7398328017603709E+27 1.7850847375091533E+18 8.7578215617990429E-01 0.0000000000000000E+00 1.3764723665458568E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.5532627225897085E-11 4.9358018177564916E-01 0.0000000000000000E+00 4.9578575722308876E-01 1.0572166621608346E-02 6.1873315827504905E-05 2.1008273822795106E-08 1.4955164698149411E-14 7.1692359611478422E-22 7.1790786326859014E-31 1.4876975226438632E-41 3.7999730898720187E-54 5.3427528740081147E-68 0.0000000000000000E+00 3.4889056659987155E-85 --- ---
- 2: 2.4523015847725093E+29 2.8234348160867123E+06 1.1277411288788629E+01 2.5994723904797511E+09 6.5316328931995463E+08 1.7364420362145372E+27 1.7841724049633684E+18 8.7725281238296449E-01 0.0000000000000000E+00 1.3742580305432508E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.2661329013172279E-11 4.9639124409260066E-01 0.0000000000000000E+00 4.9762978074249253E-01 5.9539598402519392E-03 2.5010401070079396E-05 4.8809122993768916E-09 1.8045652482983494E-15 4.3260600057834332E-23 2.1981176957019584E-32 2.3448843272576899E-43 3.3575583229425822E-56 3.3277794120289599E-70 0.0000000000000000E+00 2.1258154376500450E-87 --- ---
- 3: 4.4308952902951118E+29 3.4399684016552879E+06 1.2217327729500658E+01 2.5955467637519984E+09 6.5257814037731171E+08 1.7329284044904201E+27 1.7831630852685683E+18 8.7727610646353127E-01 0.0000000000000000E+00 1.3742579297011513E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.2535980237389238E-11 4.9639137229971608E-01 0.0000000000000000E+00 4.9762986534575843E-01 5.9537480462358008E-03 2.5009385417146766E-05 4.8803253427495700E-09 1.8042746450460324E-15 4.3250688743988306E-23 2.1974806604209711E-32 2.3440194448871542E-43 3.3561005597120036E-56 3.3264049434352102E-70 0.0000000000000000E+00 2.1250987377916762E-87 --- ---
- 4: 6.9611778106595762E+29 4.0003631351009090E+06 1.3408250118714866E+01 2.5913141339636154E+09 6.5194625052973056E+08 1.7291419917005391E+27 1.7820736963262781E+18 8.7730120917800858E-01 0.0000000000000000E+00 1.3742577825904906E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.2354277368570563E-11 4.9639155933127749E-01 0.0000000000000000E+00 4.9762998876525644E-01 5.9534390795458825E-03 2.5007902083216654E-05 4.8794714802551135E-09 1.8038517947569358E-15 4.3236282769061933E-23 2.1965554003641296E-32 2.3427651501541512E-43 3.3539897859916829E-56 3.3244149207592624E-70 0.0000000000000000E+00 2.1240598059076596E-87 --- ---
- 5: 9.9999999999953474E+29 4.5153730027975785E+06 1.4653177042271086E+01 2.5868206293151174E+09 6.5127456126976633E+08 1.7251244867758950E+27 1.7809158737475571E+18 8.7732787377896748E-01 0.0000000000000000E+00 1.3742575995381129E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.2129565100457358E-11 4.9639179205823980E-01 0.0000000000000000E+00 4.9763014233612612E-01 5.9530546310241740E-03 2.5006054056935883E-05 4.8784122845083512E-09 1.8033271273985515E-15 4.3218429567022635E-23 2.1954096453745198E-32 2.3412145368225814E-43 3.3513848930889544E-56 3.3219592219449888E-70 0.0000000000000000E+00 2.1227760197800650E-87 --- ---
- 6: 1.3428633252745263E+30 4.9834236111063315E+06 1.5860624182886149E+01 2.5821996740378056E+09 6.5058302538910794E+08 1.7209954867036133E+27 1.7797238233828303E+18 8.7735532439142805E-01 0.0000000000000000E+00 1.3742573905957368E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.1874577518625144E-11 4.9639205770130373E-01 0.0000000000000000E+00 4.9763031762465210E-01 5.9526158130565219E-03 2.5003941894568767E-05 4.8772072333128143E-09 1.8027300571562606E-15 4.3198138636366795E-23 2.1941085471718526E-32 2.3394567894417824E-43 3.3484374458367477E-56 3.3191807603108000E-70 0.0000000000000000E+00 2.1213213804447119E-87 --- ---
- 7: 1.7264416518296091E+30 5.4207770163566116E+06 1.7032416108200611E+01 2.5774990149845066E+09 6.4987880725935042E+08 1.7167978262869227E+27 1.7785097646031053E+18 8.7738328789484132E-01 0.0000000000000000E+00 1.3742571615661287E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.1596619940884702E-11 4.9639234888310824E-01 0.0000000000000000E+00 4.9763050976208861E-01 5.9521348136990174E-03 2.5001623605560203E-05 4.8758907096525848E-09 1.8020775874276969E-15 4.3175993759420677E-23 2.1926897902176065E-32 2.3375435014680142E-43 3.3452351118596265E-56 3.3161621616881269E-70 0.0000000000000000E+00 2.1197386413313842E-87 --- ---
- 8: 2.1519480749731376E+30 5.8360557299696757E+06 1.8172655330222810E+01 2.5726883211790681E+09 6.4915736249465525E+08 1.7125045807938274E+27 1.7772657711054607E+18 8.7741195261253468E-01 0.0000000000000000E+00 1.3742569131956110E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.1296792529956561E-11 4.9639266465489373E-01 0.0000000000000000E+00 4.9763071812175824E-01 5.9516132014287952E-03 2.4999106143309388E-05 4.8744678410987381E-09 1.8013722292511264E-15 4.3152085542354806E-23 2.1911594051758297E-32 2.3354834148747907E-43 3.3417935369317811E-56 3.3129181326915799E-70 0.0000000000000000E+00 2.1180350445592672E-87 --- ---
- 9: 2.6199836119821814E+30 6.2341521438265052E+06 1.9284393351808973E+01 2.5677559619264841E+09 6.4841692613618171E+08 1.7081055703630039E+27 1.7759887199548001E+18 8.7744139540272859E-01 0.0000000000000000E+00 1.3742566462811316E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0976251063534823E-11 4.9639300400353847E-01 0.0000000000000000E+00 4.9763094203451730E-01 5.9510526510347548E-03 2.4996396977860363E-05 4.8729440307303185E-09 1.8006166300565348E-15 4.3126509063216608E-23 2.1895237004531633E-32 2.3332856186538593E-43 3.3381288861706935E-56 3.3094638456383759E-70 0.0000000000000000E+00 2.1162180812649764E-87 --- ---
- 10: 3.1304576633028770E+30 6.6179047585754618E+06 2.0369302853445188E+01 2.5627020810346384E+09 6.4765749005888736E+08 1.7036011382431491E+27 1.7746785238500211E+18 8.7747162274155999E-01 0.0000000000000000E+00 1.3742563618389131E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0636403636976653E-11 4.9639336563713937E-01 0.0000000000000000E+00 4.9763118064729062E-01 5.9504552977739482E-03 2.4993505822460360E-05 4.8713258985789309E-09 1.7998140412253956E-15 4.3099379556316302E-23 2.1877902591720624E-32 2.3309608716640367E-43 3.3342600210880854E-56 3.3058169901938215E-70 0.0000000000000000E+00 2.1142965821931396E-87 --- ---
- 11: 3.6825249259031809E+30 6.9889261255489606E+06 2.1427898611613450E+01 2.5575351209866714E+09 6.4688029068901324E+08 1.6989990220089547E+27 1.7733372475630684E+18 8.7750259113756934E-01 0.0000000000000000E+00 1.3742560611658105E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0278976055503224E-11 4.9639374790699831E-01 0.0000000000000000E+00 4.9763143287162109E-01 5.9498238661884759E-03 2.4990445280271581E-05 4.8696215981754646E-09 1.7989684762618004E-15 4.3070837546384167E-23 2.1859682582420278E-32 2.3285220062085015E-43 3.3302091304250482E-56 3.3019983691692425E-70 0.0000000000000000E+00 2.1122810496529044E-87 --- ---
- 12: 4.2745430717472685E+30 7.3480565654253904E+06 2.2459819884915898E+01 2.5522697971001863E+09 6.4608751108877027E+08 1.6943125253004558E+27 1.7719685956561208E+18 8.7753421887130068E-01 0.0000000000000000E+00 1.3742557458545072E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.9906021475573067E-11 4.9639414878829830E-01 0.0000000000000000E+00 4.9763169737094753E-01 5.9491617019704086E-03 2.4987231025582931E-05 4.8678408660713788E-09 1.7980847367345006E-15 4.3041049488962916E-23 2.1840684994550419E-32 2.3259839434243408E-43 3.3260017128627312E-56 3.2980318855051810E-70 0.0000000000000000E+00 2.1101836714998510E-87 --- ---
- 13: 4.9040548040414248E+30 7.6956340350551531E+06 2.3464077110868249E+01 2.5469257341007504E+09 6.4528208072571349E+08 1.6895592846521581E+27 1.7705775693717870E+18 8.7756639378778056E-01 0.0000000000000000E+00 1.3742554177830675E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.9519899817912418E-11 4.9639456589338204E-01 0.0000000000000000E+00 4.9763197256939484E-01 5.9484727499722898E-03 2.4983881724620465E-05 4.8659949260625135E-09 1.7971683662030262E-15 4.3010205985729960E-23 2.1821032862225944E-32 2.3233635035965846E-43 3.3216662230699573E-56 3.2939442141136601E-70 0.0000000000000000E+00 2.1080181691333264E-87 --- ---
- 14: 5.5677969247037119E+30 8.0316658960891161E+06 2.4439252063960975E+01 2.5415264183306637E+09 6.4446752145831203E+08 1.6847603211913254E+27 1.7691702032741471E+18 8.7759897923388819E-01 0.0000000000000000E+00 1.3742550790873088E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.9123237669690740E-11 4.9639499650687446E-01 0.0000000000000000E+00 4.9763225667497513E-01 5.9477614961398455E-03 2.4980418779510765E-05 4.8640962997200480E-09 1.7962255576047907E-15 4.2978518458392755E-23 2.1800862033600352E-32 2.3206790909060008E-43 3.3172335175509736E-56 3.2897642869968791E-70 0.0000000000000000E+00 2.1057995452731372E-87 --- ---
- 15: 6.2617378337997012E+30 8.3559447139972579E+06 2.5383658442121714E+01 2.5360983023217525E+09 6.4364781544344842E+08 1.6799392314729949E+27 1.7677533397159368E+18 8.7763181913264676E-01 0.0000000000000000E+00 1.3742547321208441E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.8718874927057992E-11 4.9639543763647798E-01 0.0000000000000000E+00 4.9763254771312521E-01 5.9470328835652337E-03 2.4976865942738596E-05 4.8621585535341904E-09 1.7952630290315472E-15 4.2946214802458823E-23 2.1780318338992884E-32 2.3179502999284133E-43 3.3127361816986630E-56 3.2855226678995799E-70 0.0000000000000000E+00 2.1035437701940501E-87 --- ---
- 16: 6.9811435023736388E+30 8.6681302269312218E+06 2.6295471724746040E+01 2.5306699834313049E+09 6.4282728328137362E+08 1.6751214478057925E+27 1.7663344203384131E+18 8.7766474268160555E-01 0.0000000000000000E+00 1.3742543794057452E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.8309802061415075E-11 4.9639588607569696E-01 0.0000000000000000E+00 4.9763284356810966E-01 5.9462922088458752E-03 2.4973248830373698E-05 4.8601960014947168E-09 1.7942878771389275E-15 4.2913534345415083E-23 2.1759554341193439E-32 2.3151974734308413E-43 3.3082077887086044E-56 3.2812508635535059E-70 0.0000000000000000E+00 2.1012674300041361E-87 --- ---
- 17: 7.7206704983561684E+30 8.9678097529878933E+06 2.7172835393520693E+01 2.5252714211066985E+09 6.4201046709275270E+08 1.6703335367063126E+27 1.7649212857080701E+18 8.7769756890045636E-01 0.0000000000000000E+00 1.3742540235769706E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.7899092029530922E-11 4.9639633847448683E-01 0.0000000000000000E+00 4.9763314202964487E-01 5.9455450053697532E-03 2.4969594364932733E-05 4.8582233823571272E-09 1.7933074176613307E-15 4.2880722436186527E-23 2.1738725878886667E-32 2.3124412402076332E-43 3.3036821384592445E-56 3.2769806160349295E-70 0.0000000000000000E+00 2.0989873595856810E-87 --- ---
- 18: 8.4744831964120764E+30 9.2545441246517897E+06 2.8013948513742058E+01 2.5199331804435620E+09 6.4120201668706095E+08 1.6656025246378354E+27 1.7635219794288033E+18 8.7773011111279631E-01 0.0000000000000000E+00 1.3742536673230282E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.7489829922375546E-11 4.9639679141469839E-01 0.0000000000000000E+00 4.9763344084267924E-01 5.9447969186936832E-03 2.4965930172197231E-05 4.8562555261658380E-09 1.7923290202051025E-15 4.2848024909976810E-23 2.1717988559044488E-32 2.3097020537147567E-43 3.2991925101509414E-56 3.2727432072207254E-70 0.0000000000000000E+00 2.0967202760466935E-87 --- ---
- 19: 9.2363909657969134E+30 9.5279033824757971E+06 2.8817138231292226E+01 2.5146857026595750E+09 6.4040657894854760E+08 1.6609552515844263E+27 1.7621445570796854E+18 8.7776218136339279E-01 0.0000000000000000E+00 1.3742533133255096E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.7085043542314201E-11 4.9639724148695019E-01 0.0000000000000000E+00 4.9763373775810715E-01 5.9440535795806703E-03 2.4962283958831789E-05 4.8543070248644481E-09 1.7913599446497343E-15 4.2815682672551698E-23 2.1697494351882686E-32 2.3069997513679169E-43 3.2947709600606172E-56 3.2685688040924038E-70 0.0000000000000000E+00 2.0944824277763869E-87 --- ---
- 20: 9.9999999999996709E+30 9.7874948199041560E+06 2.9580919405876870E+01 2.5095586103796048E+09 6.3962869168853247E+08 1.6564177592995758E+27 1.7607969020812124E+18 8.7779359472296792E-01 0.0000000000000000E+00 1.3742529641999333E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.6687637702217608E-11 4.9639768536583972E-01 0.0000000000000000E+00 4.9763403058237915E-01 5.9433204797946374E-03 2.4958682895950394E-05 4.8523919198080253E-09 1.7904071855177597E-15 4.2783926610677529E-23 2.1677388416298797E-32 2.3043531504583406E-43 3.2904476885675718E-56 3.2644858670011569E-70 0.0000000000000000E+00 2.0922892711030417E-87 --- ---
- 21: 1.0758873610036410E+31 1.0032984999977073E+07 3.0304042908202938E+01 2.5045800594128833E+09 6.3887268381980395E+08 1.6520147242370051E+27 1.7594865516503557E+18 8.7782417340354135E-01 0.0000000000000000E+00 1.3742526224399708E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.6300334492036631E-11 4.9639811988086036E-01 0.0000000000000000E+00 4.9763431722427204E-01 5.9426028550022764E-03 2.4955153030652224E-05 4.8505234163561940E-09 1.7894773293959066E-15 4.2752972988745032E-23 2.1657806252612599E-32 2.3017796921558885E-43 3.2862504927498221E-56 3.2605206358222962E-70 0.0000000000000000E+00 2.0901551831162569E-87 --- ---
- 22: 1.1525759183621215E+31 1.0269879937475644E+07 3.1002533766351952E+01 2.4997153441896591E+09 6.3813333888583744E+08 1.6477152225789916E+27 1.7582045017058511E+18 8.7785412542904018E-01 0.0000000000000000E+00 1.3742522861569471E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.5920870843167974E-11 4.9639854743322920E-01 0.0000000000000000E+00 4.9763459926819481E-01 5.9418967387469971E-03 2.4951675206591050E-05 4.8486906899601283E-09 1.7885650082443840E-15 4.2722639716625039E-23 2.1638631205311725E-32 2.2992636435684022E-43 3.2821530192950293E-56 3.2566482255052788E-70 0.0000000000000000E+00 2.0880670760153747E-87 --- ---
- 23: 1.2313811497487103E+31 1.0502876766356327E+07 3.1690121817854585E+01 2.4948743850493007E+09 6.3739699458839476E+08 1.6434395238610194E+27 1.7569270774311375E+18 8.7788400303071679E-01 0.0000000000000000E+00 1.3742519494580678E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.5542548230528967E-11 4.9639897551506129E-01 0.0000000000000000E+00 4.9763488165663566E-01 5.9411897572556292E-03 2.4948188632712117E-05 4.8468613880072584E-09 1.7876541242943089E-15 4.2692389842392703E-23 2.1619523062623496E-32 2.2967601447213476E-43 3.2780818122297066E-56 3.2527991775970468E-70 0.0000000000000000E+00 2.0859876268358239E-87 --- ---
- 24: 1.3137275361782613E+31 1.0736228202243278E+07 3.2379285903149480E+01 2.4899710552219944E+09 6.3665054465459073E+08 1.6391115954755556E+27 1.7556315268715384E+18 8.7791433928234819E-01 0.0000000000000000E+00 1.3742516065467326E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.5158891677871324E-11 4.9639941149622113E-01 0.0000000000000000E+00 4.9763516925110424E-01 5.9404697393003695E-03 2.4944633200603391E-05 4.8450040825336696E-09 1.7867290213272730E-15 4.2661703609137020E-23 2.1600153487505573E-32 2.2942261617063527E-43 3.2739668065003088E-56 3.2489071385487695E-70 0.0000000000000000E+00 2.0838809086826673E-87 --- ---
- 25: 1.4012262626283836E+31 1.0974017834780827E+07 3.3082049278968370E+01 2.4849181403424931E+09 6.3588067292159796E+08 1.6346546492297988E+27 1.7542946911601833E+18 8.7794567927324663E-01 0.0000000000000000E+00 1.3742512514144719E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.4763305949313752E-11 4.9639986301599964E-01 0.0000000000000000E+00 4.9763546709050105E-01 5.9397240693470476E-03 2.4940946291611248E-05 4.8430865928021045E-09 1.7857736489204044E-15 4.2630050636066004E-23 2.1580188404048424E-32 2.2916181661154932E-43 3.2697375240998468E-56 3.2449052476355518E-70 0.0000000000000000E+00 2.0817104358308627E-87 --- ---
- 26: 1.4957694626029211E+31 1.1220389024828540E+07 3.3810646242637397E+01 2.4796225626296864E+09 6.3507312184444439E+08 1.6299869483348296E+27 1.7528917289567053E+18 8.7797861033509328E-01 0.0000000000000000E+00 1.3742508775308190E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.4348744498495906E-11 4.9640033837742015E-01 0.0000000000000000E+00 4.9763578065118003E-01 5.9389390364423533E-03 2.4937059523642205E-05 4.8410743453980732E-09 1.7847707429705735E-15 4.2596862940742279E-23 2.1559271033160592E-32 2.2888899307975790E-43 3.2653195067137487E-56 3.2407227335340889E-70 0.0000000000000000E+00 2.0794372859576948E-87 --- ---
- 27: 1.5996501841471306E+31 1.1479754829234218E+07 3.4578137814935644E+01 2.4739803793954911E+09 6.3421192028975523E+08 1.6250174447711517E+27 1.7513947638252308E+18 8.7801379445266647E-01 0.0000000000000000E+00 1.3742504775042169E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.3907363420221818E-11 4.9640084697837922E-01 0.0000000000000000E+00 4.9763611613126096E-01 5.9380991223591346E-03 2.4932895153868027E-05 4.8389286303646628E-09 1.7837009516498146E-15 4.2561506468444056E-23 2.1537004106721442E-32 2.2859902496977507E-43 3.2606306704094743E-56 3.2362814165569773E-70 0.0000000000000000E+00 2.0770181306213029E-87 --- ---
- 28: 1.7157205765521055E+31 1.1757008452538870E+07 3.5399032358766640E+01 2.4678711048730555E+09 6.3327850021509886E+08 1.6196408573914458E+27 1.7497713300834673E+18 8.7805200589798438E-01 0.0000000000000000E+00 1.3742500426873614E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.3430136321297638E-11 4.9640139981344433E-01 0.0000000000000000E+00 4.9763648078149031E-01 5.9371861731706372E-03 2.4928361848995069E-05 4.8366046226045683E-09 1.7825418407757201E-15 4.2523249007986063E-23 2.1512929943803724E-32 2.2828604148740445E-43 3.2555773161326647E-56 3.2314918550230552E-70 0.0000000000000000E+00 2.0744030201025293E-87 --- ---
- 29: 1.8476059264908175E+31 1.2057749707813691E+07 3.6289955920433187E+01 2.4611508766748266E+09 6.3225062606488156E+08 1.6137317840169589E+27 1.7479824813178806E+18 8.7809417750368213E-01 0.0000000000000000E+00 1.3742495626975000E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.2906407325476630E-11 4.9640201008378682E-01 0.0000000000000000E+00 4.9763688330734790E-01 5.9361783924038103E-03 2.4923349495112862E-05 4.8340490331478845E-09 1.7812667096091506E-15 4.2481222335399644E-23 2.1486507069820088E-32 2.2794312887723542E-43 3.2500495443145499E-56 3.2262488814366992E-70 0.0000000000000000E+00 2.0715327628073908E-87 --- ---
- 30: 1.9999999999999630E+31 1.2388541113701591E+07 3.7270411980280990E+01 2.4536439047366352E+09 6.3110104571699452E+08 1.6071373779205217E+27 1.7459803965538378E+18 8.7814145981850844E-01 0.0000000000000000E+00 1.3742490248173601E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.2323360835934554E-11 4.9640269395890974E-01 0.0000000000000000E+00 4.9763733437115898E-01 5.9350490837448786E-03 2.4917722654782530E-05 4.8311972434578000E-09 1.7798431414268987E-15 4.2434376284364323E-23 2.1457081995358138E-32 2.2756198077999387E-43 3.2439158250159564E-56 3.2204262663247839E-70 0.0000000000000000E+00 2.0683357207052723E-87 --- ---
- 31: 2.1790790876294910E+31 1.2757206660925770E+07 3.8363668491028854E+01 2.4451315012203193E+09 6.2979574700030184E+08 1.5996680130617767E+27 1.7437052724134938E+18 8.7819529874772562E-01 0.0000000000000000E+00 1.3742484132362467E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.1665390751379998E-11 4.9640347154161424E-01 0.0000000000000000E+00 4.9763784722808396E-01 5.9337650584609589E-03 2.4911312194828724E-05 4.8279697640026827E-09 1.7782312057872054E-15 4.2381422302306797E-23 2.1423854715882763E-32 2.2713247537525063E-43 3.2370164819284739E-56 3.2138702360342043E-70 0.0000000000000000E+00 2.0647238134861439E-87 --- ---
- 32: 2.3876492120280019E+31 1.3162910796113437E+07 3.9567317894404411E+01 2.4354734443600540E+09 6.2831251802121341E+08 1.5912040159055102E+27 1.7411176128059231E+18 8.7825667508922622E-01 0.0000000000000000E+00 1.3742477178836543E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0923813149041492E-11 4.9640435563675134E-01 0.0000000000000000E+00 4.9763843031804617E-01 5.9323051824963875E-03 2.4904007452249440E-05 4.8243192978254513E-09 1.7764069333513341E-15 4.2321606988570193E-23 2.1386364853293961E-32 2.2664897800528813E-43 3.2292651103160862E-56 3.2064954928097544E-70 0.0000000000000000E+00 2.0606449657274684E-87 --- ---
- 33: 2.6284136724418553E+31 1.3604033253514983E+07 4.0876591224351827E+01 2.4246354013344665E+09 6.2664521641011965E+08 1.5817194252845731E+27 1.7382057311248660E+18 8.7832592349841954E-01 0.0000000000000000E+00 1.3742469365659522E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0098938031296513E-11 4.9640534903446915E-01 0.0000000000000000E+00 4.9763908547464497E-01 5.9306648611944564E-03 2.4895779340488348E-05 4.8202411034583125E-09 1.7743675358807830E-15 4.2254877711882278E-23 2.1344593225133645E-32 2.2611159158536997E-43 3.2206676946354730E-56 3.1983036207800819E-70 0.0000000000000000E+00 2.0560938821635938E-87 --- ---
- 34: 2.9038797845213166E+31 1.4078259907851031E+07 4.2284623232521298E+01 2.4126022962653780E+09 6.2479052286387765E+08 1.5712057956621989E+27 1.7349626957857910E+18 8.7840327613532398E-01 0.0000000000000000E+00 1.3742460688577518E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.9193423713393870E-11 4.9640645227685487E-01 0.0000000000000000E+00 4.9763981304801119E-01 5.9288432135405937E-03 2.4886616648638644E-05 4.8157403129399609E-09 1.7721151033657527E-15 4.2181344085431314E-23 2.1298622716644141E-32 2.2552174044928899E-43 3.2112511469480854E-56 3.1893152321121709E-70 0.0000000000000000E+00 2.0510749127915034E-87 --- ---
- 35: 3.2162587678984315E+31 1.4582696748430816E+07 4.3782790564341418E+01 2.3993794344624929E+09 6.2274813437898564E+08 1.5596730798109110E+27 1.7313866849984865E+18 8.7848885328920423E-01 0.0000000000000000E+00 1.3742451162326043E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.8212358765240698E-11 4.9640766349171705E-01 0.0000000000000000E+00 4.9764061179548968E-01 5.9268433460276503E-03 2.4876527709963838E-05 4.8108322248115119E-09 1.7696567689328347E-15 4.2101280797958749E-23 2.1248639010959545E-32 2.2488215219772273E-43 3.2010625817397768E-56 3.1795693245610335E-70 0.0000000000000000E+00 2.0456018993102230E-87 --- ---
- 36: 3.5673624784155728E+31 1.5113992143519342E+07 4.5361078280938138E+01 2.3849929666940808E+09 6.2052086591269529E+08 1.5471498837952855E+27 1.7274811943222333E+18 8.7858265675265035E-01 0.0000000000000000E+00 1.3742440821007767E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7163205102647791E-11 4.9640897834449282E-01 0.0000000000000000E+00 4.9764147885032534E-01 5.9246724312838747E-03 2.4865541181688249E-05 4.8055420293282542E-09 1.7670045969087936E-15 4.2015121016394423E-23 2.1194925328056240E-32 2.2419676079382560E-43 3.1901673403837659E-56 3.1691215256468816E-70 0.0000000000000000E+00 2.0396974787670689E-87 --- ---
- 37: 3.9585013844433089E+31 1.5668455740931230E+07 4.7008439216875793E+01 2.3694897501794739E+09 6.1811466839038432E+08 1.5336831482421232E+27 1.7232551104909445E+18 8.7868456563152231E-01 0.0000000000000000E+00 1.3742429717511252E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6055599417847447E-11 4.9641039011207749E-01 0.0000000000000000E+00 4.9764240977082891E-01 5.9223415852470412E-03 2.4853705876022636E-05 4.7999039947480036E-09 1.7641752068286426E-15 4.1923441095823657E-23 2.1137851769187156E-32 2.2347054225895488E-43 3.1786460085971578E-56 3.1580414583337013E-70 0.0000000000000000E+00 2.0333919574418384E-87 --- ---
- 38: 4.3903886984728140E+31 1.6242166508328747E+07 4.8713122667890268E+01 2.3529366692248764E+09 6.1553857135344172E+08 1.5193373187099847E+27 1.7187226648392696E+18 8.7879433433140475E-01 0.0000000000000000E+00 1.3742417922026203E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4901022746095275E-11 4.9641188987151880E-01 0.0000000000000000E+00 4.9764339866532586E-01 5.9198655546217069E-03 2.4841089661486435E-05 4.7939601971476723E-09 1.7611891720167867E-15 4.1826938208819277E-23 2.1077860414250083E-32 2.2270930133458863E-43 3.1665907754679608E-56 3.1464095544544140E-70 0.0000000000000000E+00 2.0267219135755789E-87 --- ---
- 39: 4.8630558330374140E+31 1.6831066357737958E+07 5.0462960801847260E+01 2.3354194735629597E+09 6.1280455725641000E+08 1.5041930667599049E+27 1.7139032765422676E+18 8.7891159258898932E-01 0.0000000000000000E+00 1.3742405519786818E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3712359857998728E-11 4.9641346678685561E-01 0.0000000000000000E+00 4.9764443838181427E-01 5.9172622423200273E-03 2.4827777527822913E-05 4.7877589166147023E-09 1.7580702509146065E-15 4.1726403117298469E-23 2.1015447679382153E-32 2.2191943136301248E-43 3.1541015269788258E-56 3.1343136755138961E-70 0.0000000000000000E+00 2.0197287041984210E-87 --- ---
- 40: 5.3757843040777123E+31 1.7431038837950345E+07 5.2245610366192786E+01 2.3170411848362384E+09 6.0992737277385187E+08 1.4883456192399087E+27 1.7088212921565100E+18 8.7903584755436959E-01 0.0000000000000000E+00 1.3742392608228865E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.2503379738120298E-11 4.9641510847050779E-01 0.0000000000000000E+00 4.9764552074672369E-01 5.9145521099361826E-03 2.4813868965203485E-05 4.7813528430628811E-09 1.7548445193313904E-15 4.1622690555231655E-23 2.0951145552657803E-32 2.2110766980770556E-43 3.1412820448570066E-56 3.1218458719929606E-70 0.0000000000000000E+00 2.0124570364360483E-87 --- ---
- 41: 5.9270588244899706E+31 1.8037974313670058E+07 5.4048753448475615E+01 2.2979201168612275E+09 6.0692428130806506E+08 1.4719027510275410E+27 1.7035056252395643E+18 8.7916648803761577E-01 0.0000000000000000E+00 1.3742379293781116E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1288175407121403E-11 4.9641680139116579E-01 0.0000000000000000E+00 4.9764663683423377E-01 5.9117575036518434E-03 2.4799474852284756E-05 4.7747972381609904E-09 1.7515394737548984E-15 4.1516689634782925E-23 2.0885503236671201E-32 2.2028086918831189E-43 3.1282366128403902E-56 3.1090995419442344E-70 0.0000000000000000E+00 2.0049537276370594E-87 --- ---
- 42: 6.5145456094108000E+31 1.8647823997195538E+07 5.5860263855973507E+01 2.2781875556697350E+09 6.0381476065160561E+08 1.4549824978647552E+27 1.6979892989240371E+18 8.7930279108919196E-01 0.0000000000000000E+00 1.3742365688517141E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0080604078122604E-11 4.9641853129945934E-01 0.0000000000000000E+00 4.9764777724718190E-01 5.9089019510537395E-03 2.4784714065469147E-05 4.7681481833221497E-09 1.7481831684171579E-15 4.1409296312369917E-23 2.0819070437183140E-32 2.1944579805323456E-43 3.1150672275323346E-56 3.0961671479551037E-70 0.0000000000000000E+00 1.9972667260415315E-87 --- ---
- 43: 7.1350988737330512E+31 1.9256645413250718E+07 5.7668346818800238E+01 2.2579851506332059E+09 6.0062015041893196E+08 1.4377106505799734E+27 1.6923088951899535E+18 8.7944393108184615E-01 0.0000000000000000E+00 1.3742351906878252E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8893767474859534E-11 4.9642028364459823E-01 0.0000000000000000E+00 4.9764893239186719E-01 5.9060094731476290E-03 2.4769710021423864E-05 4.7614610157899524E-09 1.7448034360331489E-15 4.1301389412221349E-23 2.0752383155417389E-32 2.1860898061467756E-43 3.1018715004589259E-56 3.0831385476011002E-70 0.0000000000000000E+00 1.9894444099241173E-87 --- ---
- 44: 7.7847971902777501E+31 1.9860641631338850E+07 5.9461658719960326E+01 2.2374620765630918E+09 5.9736325526154220E+08 1.4202180983228286E+27 1.6865039171030623E+18 8.7958899140526381E-01 0.0000000000000000E+00 1.3742338062639345E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7739566421123004E-11 4.9642204396015771E-01 0.0000000000000000E+00 4.9765009273235872E-01 5.9031039476043620E-03 2.4754587339790472E-05 4.7547890173938555E-09 1.7414272246818300E-15 4.1193811046877354E-23 2.0685952402652132E-32 2.1777657744826765E-43 3.0887412336214165E-56 3.0700998969317312E-70 0.0000000000000000E+00 1.9815351333303417E-87 --- ---
- 45: 8.4590098686623695E+31 2.0456196115033653E+07 6.1229412657574365E+01 2.2167720363245249E+09 5.9406791166987813E+08 1.4026380944673851E+27 1.6806160737045094E+18 8.7973697878802160E-01 0.0000000000000000E+00 1.3742324266240979E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6628355042290835E-11 4.9642379820331517E-01 0.0000000000000000E+00 4.9765124901397800E-01 5.9002085491090253E-03 2.4739468776322882E-05 4.7481823837559818E-09 1.7380800660625795E-15 4.1087351666816063E-23 2.0620255868093636E-32 2.1695430463520167E-43 3.0757615748768717E-56 3.0571330197350590E-70 0.0000000000000000E+00 1.9735869521460294E-87 --- ---
- 46: 9.1524919059324317E+31 2.1039904469862662E+07 6.2961473529689670E+01 2.1960701821185141E+09 5.9075852805710578E+08 1.3851035228507025E+27 1.6746885012711465E+18 8.7988684012922813E-01 0.0000000000000000E+00 1.3742310622560238E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5568709151807387E-11 4.9642553303832110E-01 0.0000000000000000E+00 4.9765239244990500E-01 5.8973452819737170E-03 2.4724472533253611E-05 4.7416874702162346E-09 1.7347856754438217E-15 4.0982739484736123E-23 2.0555732276472821E-32 2.1614738535319417E-43 3.0630106168040987E-56 3.0443151012458488E-70 0.0000000000000000E+00 1.9656474478232351E-87 --- ---
- 47: 9.8595044599930061E+31 2.1608603817344669E+07 6.4648444971618005E+01 2.1755100395442977E+09 5.8745960953290021E+08 1.3677442428121133E+27 1.6687649385493755E+18 8.8003748157746331E-01 0.0000000000000000E+00 1.3742297229141467E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4567311732361697E-11 4.9642723606150485E-01 0.0000000000000000E+00 4.9765351486916543E-01 5.8945346094007103E-03 2.4709710004601658E-05 4.7353462856580301E-09 1.7315656714832516E-15 4.0880633661931327E-23 2.0492777970771830E-32 2.1536052605648572E-43 3.0505592877955266E-56 3.0317185574520870E-70 0.0000000000000000E+00 1.9577635643952687E-87 --- ---
- 48: 1.0573956320148394E+32 2.2159400035155769E+07 6.6281749042797287E+01 2.1552405208202939E+09 5.8419528009268463E+08 1.3506845885325142E+27 1.6628888770536325E+18 8.8018778944307230E-01 0.0000000000000000E+00 1.3742284174870324E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3628948079230323E-11 4.9642889596992879E-01 0.0000000000000000E+00 4.9765460882742835E-01 5.8917951758325933E-03 2.4695283974171878E-05 4.7291961921737483E-09 1.7284393974709428E-15 4.0781620488587414E-23 2.0431745187374686E-32 2.1459790933437796E-43 3.0384713986028481E-56 3.0194109516023691E-70 0.0000000000000000E+00 1.9499813889592683E-87 --- ---
- 49: 1.1289560604909510E+32 2.2689692707209401E+07 6.7853698284178890E+01 2.1354031116601272E+09 5.8098881572891355E+08 1.3340410914619281E+27 1.6571027102054828E+18 8.8033665238691650E-01 0.0000000000000000E+00 1.3742271539047650E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2756594886631837E-11 4.9643050267920508E-01 0.0000000000000000E+00 4.9765566768428460E-01 5.8891436132215112E-03 2.4681287251491991E-05 4.7232697640049117E-09 1.7254238229518276E-15 4.0686211774332922E-23 2.0372941510962962E-32 2.1386319657310524E-43 3.0268037374229666E-56 3.0074548640887796E-70 0.0000000000000000E+00 1.9423458288372679E-87 --- ---
- 50: 1.1999999999999980E+32 2.3197197331511736E+07 6.9357559037430889E+01 2.1161293103289676E+09 5.7786220212843943E+08 1.3179204846641979E+27 1.6514469066712131E+18 8.8048298420705629E-01 0.0000000000000000E+00 1.3742259390804961E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1951582127900007E-11 4.9643204739788155E-01 0.0000000000000000E+00 4.9765668565191701E-01 5.8865944189360848E-03 2.4667801708078436E-05 4.7175947616567883E-09 1.7225335053702094E-15 4.0594844752594091E-23 2.0316630076663524E-32 2.1315953519872795E-43 3.0156061429387037E-56 2.9959076618151961E-70 0.0000000000000000E+00 1.9349001650612294E-87 --- ---
- 51: 1.2699093329921292E+32 2.3679964138518609E+07 7.0787604124129032E+01 2.0975383877819684E+09 5.7483573011579013E+08 1.3024180354991148E+27 1.6459592336890419E+18 8.8062574645657432E-01 0.0000000000000000E+00 1.3742247788801263E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1213804400641272E-11 4.9643352266604546E-01 0.0000000000000000E+00 4.9765765782022425E-01 5.8841598926452094E-03 2.4654897666227580E-05 4.7121941852403592E-09 1.7197805948562532E-15 4.0507882966973036E-23 2.0263030208679776E-32 2.1248956725595656E-43 3.0049215224225343E-56 2.9848211535452668E-70 0.0000000000000000E+00 1.9276854887055620E-87 --- ---
- 52: 1.3389094018350411E+32 2.4141759463448059E+07 7.2155041654996651E+01 2.0796304621072490E+09 5.7191044859044790E+08 1.2875290135893447E+27 1.6406427765529300E+18 8.8076479008627961E-01 0.0000000000000000E+00 1.3742236715723061E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0537965862575462E-11 4.9643493068416034E-01 0.0000000000000000E+00 4.9765858564490695E-01 5.8818363926286827E-03 2.4642560699205522E-05 4.7070560229554259E-09 1.7171593826451135E-15 4.0425128845814690E-23 2.0212016902960007E-32 2.1185166893933025E-43 2.9947255719974843E-56 2.9741782688525591E-70 0.0000000000000000E+00 1.9206987688508355E-87 --- ---
- 53: 1.4072171717118605E+32 2.4585783277154546E+07 7.3469390564610222E+01 2.0623051612982974E+09 5.6907089291134179E+08 1.2731656278943272E+27 1.6354704984093581E+18 8.8090076006620255E-01 0.0000000000000000E+00 1.3742226094985764E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9157295907686708E-12 4.9643628118958738E-01 0.0000000000000000E+00 4.9765947554715084E-01 5.8796078417462433E-03 2.4630709447436226E-05 4.7021415651124915E-09 1.7146504648455581E-15 4.0345956493503101E-23 2.0163202197220158E-32 2.1124095210570483E-43 2.9849418034675549E-56 2.9639062803375580E-70 0.0000000000000000E+00 1.9138992147710577E-87 --- ---
- 54: 1.4750432780659248E+32 2.5014794625364851E+07 7.4738854192949034E+01 2.0454738449601145E+09 5.6630329989835405E+08 1.2592508232065483E+27 1.6304182018521411E+18 8.8103424195320068E-01 0.0000000000000000E+00 1.3742215860192529E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.3401399270490211E-12 4.9643758262444670E-01 0.0000000000000000E+00 4.9766033309357766E-01 5.8774603022011696E-03 2.4619273005884314E-05 4.6974175923981934E-09 1.7122371598090723E-15 4.0269829344765045E-23 2.0116253848983791E-32 2.1065323821838471E-43 2.9755047722411579E-56 2.9539423781278713E-70 0.0000000000000000E+00 1.9072509517023502E-87 --- ---
- 55: 1.5425939774471797E+32 2.5431205757314865E+07 7.5970600417127372E+01 2.0290572669893501E+09 5.6359526185556030E+08 1.2457161668651641E+27 1.6254639403662129E+18 8.8116577497070003E-01 0.0000000000000000E+00 1.3742205953107410E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 8.8053521486613377E-12 4.9643884239330588E-01 0.0000000000000000E+00 4.9766116316629266E-01 5.8753815498516857E-03 2.4608188878330137E-05 4.6928552455461506E-09 1.7099049495552293E-15 4.0196281590762326E-23 2.0070883645104451E-32 2.1008490686389966E-43 2.9663576693847273E-56 2.9442314604877190E-70 0.0000000000000000E+00 1.9007218820093199E-87 --- ---
- 56: 1.6100730319096502E+32 2.5837154241391089E+07 7.7170976422463568E+01 2.0129837326127000E+09 5.6093545210587955E+08 1.2325001898393174E+27 1.6205875492171960E+18 8.8129586257258907E-01 0.0000000000000000E+00 1.3742196322066329E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 8.3064237628708061E-12 4.9644006706519772E-01 0.0000000000000000E+00 4.9766197009618418E-01 5.8733607405086416E-03 2.4597401363096907E-05 4.6884291514191448E-09 1.7076410471918205E-15 4.0124903859540799E-23 2.0026838411084282E-32 2.0953277979961356E-43 2.9574504847843114E-56 2.9347244420256537E-70 0.0000000000000000E+00 1.8942828037161393E-87 --- ---
- 57: 1.6776835556955623E+32 2.6234559301332608E+07 7.8345676364962060E+01 1.9971876171890814E+09 5.5831340266166270E+08 1.2195470610252394E+27 1.6157702631094856E+18 8.8142498120155000E-01 0.0000000000000000E+00 1.3742186920712417E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.8391516289147933E-12 4.9644126253441123E-01 0.0000000000000000E+00 4.9766275776901020E-01 5.8713881443520060E-03 2.4586860259966193E-05 4.6841167367376370E-09 1.7054340566278413E-15 4.0055331998795201E-23 1.9983892983256283E-32 2.0899403068269126E-43 2.9487385804319195E-56 2.9253769321695139E-70 0.0000000000000000E+00 1.8879067121880698E-87 --- ---
- 58: 1.7456298521421902E+32 2.6625166656634189E+07 7.9499874746372015E+01 1.9816081537589254E+09 5.5571932041693819E+08 1.2068055098654733E+27 1.6109943976023580E+18 8.8155358774505732E-01 0.0000000000000000E+00 1.3742177706973939E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.3999436044252351E-12 4.9644243415043743E-01 0.0000000000000000E+00 4.9766352971112637E-01 5.8694549313095101E-03 2.4576519818481865E-05 4.6798976807682534E-09 1.7032737006880314E-15 3.9987238148536625E-23 1.9941844625784083E-32 2.0846611359899596E-43 2.9401815619972133E-56 2.9161481814796089E-70 0.0000000000000000E+00 1.8815682330781698E-87 --- ---
- 59: 1.8141192685407427E+32 2.7010584877894107E+07 8.0638334570353621E+01 1.9661884225854797E+09 5.5314393205200958E+08 1.1942279364989508E+27 1.6062430776533819E+18 8.8168212605461771E-01 0.0000000000000000E+00 1.3742168642225300E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.9857165198635920E-12 4.9644358682463652E-01 0.0000000000000000E+00 4.9766428915985006E-01 5.8675529948943967E-03 2.4566337869127802E-05 4.6757534719845482E-09 1.7011506004387028E-15 3.9920323521892735E-23 1.9900508522544052E-32 2.0794670550472933E-43 2.9317423696355900E-56 2.9070002232893378E-70 0.0000000000000000E+00 1.8752431495544522E-87 --- ---
- 60: 1.8833640970564785E+32 2.7392315418168969E+07 8.1765496416770077E+01 1.9508744937627432E+09 5.5057835042210269E+08 1.1817696650462523E+27 1.6015000009864456E+18 8.8181103280517370E-01 0.0000000000000000E+00 1.3742159690588272E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.5938145081610608E-12 4.9644472511908722E-01 0.0000000000000000E+00 4.9766503912206472E-01 5.8656748054814484E-03 2.4556275095057865E-05 4.6716670436627172E-09 1.6990560934178791E-15 3.9854312478833054E-23 1.9859714080400633E-32 2.0743365911401321E-43 2.9233865321846845E-56 2.8978971594618395E-70 0.0000000000000000E+00 1.8689079976352820E-87 --- ---
- 61: 1.9535835507965445E+32 2.7771777903120227E+07 8.2885553558281615E+01 1.9356146863128235E+09 5.4801395697841954E+08 1.1693883070219889E+27 1.5967492268992074E+18 8.8194074290762892E-01 0.0000000000000000E+00 1.3742150818339640E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.2219431766330042E-12 4.9644585332189595E-01 0.0000000000000000E+00 4.9766578242388815E-01 5.8638132859500126E-03 2.4546294410818256E-05 4.6676224692175435E-09 1.6969820813089591E-15 3.9788947575690078E-23 1.9819301843251354E-32 2.0692496360788465E-43 2.9150815425828588E-56 2.8888045512073493E-70 0.0000000000000000E+00 1.8625397091739573E-87 --- ---
- 62: 2.0250058457133319E+32 2.8150331862616673E+07 8.4002516245323662E+01 1.9203589158999331E+09 5.4544229601360357E+08 1.1570432099273766E+27 1.5919749832314824E+18 8.8207169464887480E-01 0.0000000000000000E+00 1.3742141993400789E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.8681162766365386E-12 4.9644697551209760E-01 0.0000000000000000E+00 4.9766652175347098E-01 5.8619617045247005E-03 2.4536360423515154E-05 4.6636047033260785E-09 1.6949209001798074E-15 3.9723985360374748E-23 1.9779120871445836E-32 2.0641871126723930E-43 2.9067963240780283E-56 2.8796888866984399E-70 0.0000000000000000E+00 1.8561152875765197E-87 --- ---
- 63: 2.0978704213002423E+32 2.8529295805859201E+07 8.5120268031390140E+01 1.9050581095184829E+09 5.4285497739669991E+08 1.1446949718829883E+27 1.5871614855733734E+18 8.8220433470384163E-01 0.0000000000000000E+00 1.3742133184889987E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.5306123212870121E-12 4.9644809561658276E-01 0.0000000000000000E+00 4.9766725969853326E-01 5.8601135807865024E-03 2.4526438957175864E-05 4.6595993581396488E-09 1.6928652080033863E-15 3.9659192737263934E-23 1.9739026475551665E-32 2.0591306858540335E-43 2.8985007640594313E-56 2.8705171037060968E-70 0.0000000000000000E+00 1.8496115044508542E-87 --- ---
- 64: 2.1724303360364681E+32 2.8909964343376942E+07 8.6242616196314160E+01 1.8896636700321133E+09 5.4024358509691846E+08 1.1323050074156078E+27 1.5822927638442767E+18 8.8233912314845897E-01 0.0000000000000000E+00 1.3742124362721134E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.2079391481290055E-12 4.9644921746111603E-01 0.0000000000000000E+00 4.9766799877999984E-01 5.8582626014495225E-03 2.4516496623796767E-05 4.6555925057878320E-09 1.6908078850986377E-15 3.9594343757461901E-23 1.9698878213654686E-32 2.0540625068328411E-43 2.8901652965631945E-56 2.8612561489837852E-70 0.0000000000000000E+00 1.8430046067657066E-87 --- ---
- 65: 2.2489548773511207E+32 2.9293623917805687E+07 8.7373338007073727E+01 1.8741269767601767E+09 5.3759958923160517E+08 1.1198351526847339E+27 1.5773524920254881E+18 8.8247653859175756E-01 0.0000000000000000E+00 1.3742115497237467E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.8988049350878849E-12 4.9645034481691513E-01 0.0000000000000000E+00 4.9766874148270579E-01 5.8564025434701241E-03 2.4506500429357274E-05 4.6515705008867935E-09 1.6887419443784205E-15 3.9529216731321510E-23 1.9658538087234786E-32 2.0489649818350510E-43 2.8817605198091184E-56 2.8518725610886356E-70 0.0000000000000000E+00 1.8362700267630910E-87 --- ---
- 66: 2.3277324306118210E+32 2.9681567604886036E+07 8.8516223899844860E+01 1.8583989107685647E+09 5.3491425969380975E+08 1.1072473008397861E+27 1.5723238172784210E+18 8.8261708354071533E-01 0.0000000000000000E+00 1.3742106558868750E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.6020944313083883E-12 4.9645148144423923E-01 0.0000000000000000E+00 4.9766949028412555E-01 5.8545272020999375E-03 2.4496417403010692E-05 4.6475198171588622E-09 1.6866604484651642E-15 3.9463591566896666E-23 1.9617868875091915E-32 2.0438205576025356E-43 2.8732568359663697E-56 2.8423320635515238E-70 0.0000000000000000E+00 1.8293820863639669E-87 --- ---
- 67: 2.4090736574335975E+32 3.0075109375684846E+07 8.9675119063229133E+01 1.8424293953678989E+09 5.3217857962260896E+08 1.0945030600663599E+27 1.5671891849314813E+18 8.8276129011447202E-01 0.0000000000000000E+00 1.3742097517803751E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3168494754602749E-12 4.9645263113404076E-01 0.0000000000000000E+00 4.9767024768182255E-01 5.8526303221416408E-03 2.4486214240915650E-05 4.6434268939012894E-09 1.6845564315509334E-15 3.9397247264650839E-23 1.9576732561428124E-32 2.0386115179348576E-43 2.8646241036755307E-56 2.8325991584000136E-70 0.0000000000000000E+00 1.8223136894526983E-87 --- ---
- 68: 2.4933150406163306E+32 3.0475598163302481E+07 9.0853964249974851E+01 1.8261669437223506E+09 5.2938315712717766E+08 1.0815634283685386E+27 1.5619301559787702E+18 8.8290972622754416E-01 0.0000000000000000E+00 1.3742088343670490E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0422530465314457E-12 4.9645379774862736E-01 0.0000000000000000E+00 4.9767101622024268E-01 5.8507055308423513E-03 2.4475856956959325E-05 4.6392779886027055E-09 1.6824228241511761E-15 3.9329959508020482E-23 1.9534988820011794E-32 2.0333197863043786E-43 2.8558312949380751E-56 2.8226367107480114E-70 0.0000000000000000E+00 1.8150359954787694E-87 --- ---
- 69: 2.5808228614584748E+32 3.0884432047395173E+07 9.2056836670981127E+01 1.8095582065513554E+09 5.2651813374954635E+08 1.0683884803641565E+27 1.5565272136460951E+18 8.8306300237516466E-01 0.0000000000000000E+00 1.3742079005215713E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.7776161803728483E-12 4.9645498526241899E-01 0.0000000000000000E+00 4.9767179851756693E-01 5.8487462706356130E-03 2.4465310531307344E-05 4.6350590316754791E-09 1.6802523787201004E-15 3.9261498284217784E-23 1.9492493513135409E-32 2.0279267291603682E-43 2.8468461471438882E-56 2.8124055137426171E-70 0.0000000000000000E+00 1.8075180663538996E-87 --- ---
- 70: 2.6719976853101119E+32 3.1303072854558893E+07 9.3287991959530089E+01 1.7925475137586586E+09 5.2357308818635201E+08 1.0549370624339551E+27 1.5509595555403853E+18 8.8322177916502875E-01 0.0000000000000000E+00 1.3742069469978460E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.5223672817011284E-12 4.9645619780347006E-01 0.0000000000000000E+00 4.9767259729306412E-01 5.8467457306262578E-03 2.4454538551317623E-05 4.6307554808821951E-09 1.6780375949153712E-15 3.9191625495894420E-23 1.9449097180338874E-32 2.0224129565835067E-43 2.8376348042427255E-56 2.8018638263664319E-70 0.0000000000000000E+00 1.7997264805601104E-87 --- ---
- 71: 2.7672794433236437E+32 3.1733061470128357E+07 9.4551907867790518E+01 1.7750764045256300E+09 5.2053693378165126E+08 1.0411664935422019E+27 1.5452048675957591E+18 8.8338677576461755E-01 0.0000000000000000E+00 1.3742059703949247E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.2760433411040693E-12 4.9645743969680534E-01 0.0000000000000000E+00 4.9767341539563614E-01 5.8446967750841860E-03 2.4443502835936849E-05 4.6263521718088130E-09 1.6757706426650079E-15 3.9120092504590438E-23 1.9404643479630795E-32 2.0167581153831070E-43 2.8281614383062498E-56 2.7909668730568360E-70 0.0000000000000000E+00 1.7916249054377499E-87 --- ---
- 72: 2.8671532128046399E+32 3.2176034166406952E+07 9.5853330796512367E+01 1.7570831410175700E+09 5.1739780825573760E+08 1.0270322699985511E+27 1.5392390757250455E+18 8.8355877945459793E-01 0.0000000000000000E+00 1.3742049671209061E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0382826912210455E-12 4.9645871551034138E-01 0.0000000000000000E+00 4.9767425583406200E-01 5.8425918676777797E-03 2.4432163037189315E-05 4.6218331618722550E-09 1.6734432817714560E-15 3.9046637565537256E-23 1.9358967555475862E-32 2.0109406711690145E-43 2.8183878449573480E-56 2.7796662962130317E-70 0.0000000000000000E+00 1.7831736197958974E-87 --- ---
- 73: 2.9721558158067136E+32 3.2633740273817584E+07 9.7197325721631586E+01 1.7385022014369907E+09 5.1414295406148636E+08 1.0124877734271920E+27 1.5330360705979420E+18 8.8373865651633421E-01 0.0000000000000000E+00 1.3742039333539916E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.8088189229121981E-12 4.9646003010441347E-01 0.0000000000000000E+00 4.9767512180961371E-01 5.8404229897620662E-03 2.4420476210153565E-05 4.6171815646022839E-09 1.6710467764048433E-15 3.8970983101594776E-23 1.9311894300476064E-32 2.0049376749748914E-43 2.8082730043896279E-56 2.7679095502552323E-70 0.0000000000000000E+00 1.7743289768616134E-87 --- ---
- 74: 3.0828833761965824E+32 3.3108061555867363E+07 9.8589330798491403E+01 1.7192637487673326E+09 5.1075858764962560E+08 9.9748398230826261E+26 1.5265674003667121E+18 8.8392736472138256E-01 0.0000000000000000E+00 1.3742028649998373E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5874756005023762E-12 4.9646138868602396E-01 0.0000000000000000E+00 4.9767601675177792E-01 5.8381815508790919E-03 2.4408396342028822E-05 4.6123793707722029E-09 1.6685718027577411E-15 3.8892832761911678E-23 1.9263236476297494E-32 1.9987245098084621E-43 2.7977725991897124E-56 2.7556392248844809E-70 0.0000000000000000E+00 1.7650427964595230E-87 --- ---
- 75: 3.1999999999999984E+32 3.3601033697991706E+07 1.0003521755463639E+02 1.6992930722497928E+09 5.0722975578731352E+08 9.8196918873053628E+26 1.5198019254037289E+18 8.8412596774463459E-01 0.0000000000000000E+00 1.3742017576442379E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3741614236273144E-12 4.9646279686902123E-01 0.0000000000000000E+00 4.9767694435788007E-01 5.8358582894767943E-03 2.4395873830177575E-05 4.6074072528397155E-09 1.6660083480861208E-15 3.8811868209798664E-23 1.9212792658740100E-32 1.9922746123994601E-43 2.7868384798354041E-56 2.7427922843891329E-70 0.0000000000000000E+00 1.7552616743627670E-87 --- ---
- 76: 3.3242477732292700E+32 3.4114870387203485E+07 1.0154135808879670E+02 1.6785099994930325E+09 5.0354017690780449E+08 9.6588872352035942E+26 1.5127054281645486E+18 8.8433565188954910E-01 0.0000000000000000E+00 1.3742006065000517E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1688654640977668E-12 4.9646426074161304E-01 0.0000000000000000E+00 4.9767790863753281E-01 5.8334431615331530E-03 2.4382854897461221E-05 4.6022443487399274E-09 1.6633455991628554E-15 3.8727745578584661E-23 1.9160344968389444E-32 1.9855591649632312E-43 2.7754180678401981E-56 2.7292992084275769E-70 0.0000000000000000E+00 1.7449261953801179E-87 --- ---
- 77: 3.4558346558849076E+32 3.4649478998750545E+07 1.0310734625782496E+02 1.6568811196737363E+09 4.9968151696894979E+08 9.4922531533547915E+26 1.5052584419440287E+18 8.8455720020061368E-01 0.0000000000000000E+00 1.3741994093032202E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.9721378374140339E-12 4.9646578318359386E-01 0.0000000000000000E+00 4.9767891148672450E-01 5.8309314164520796E-03 2.4369314365958964E-05 4.5968812632585372E-09 1.6605786501702605E-15 3.8640307432499640E-23 1.9105791250057309E-32 1.9785640239152938E-43 2.7634831556233555E-56 2.7151180349104655E-70 0.0000000000000000E+00 1.7339970220948701E-87 --- ---
- 78: 3.5949549650650617E+32 3.5204720726528428E+07 1.0473263260650421E+02 1.6344226614295721E+09 4.9565407960208917E+08 9.3200060654232914E+26 1.4974578038934735E+18 8.8479093324707758E-01 0.0000000000000000E+00 1.3741981663832394E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7848672236998394E-12 4.9646736377667222E-01 0.0000000000000000E+00 4.9767995262888137E-01 5.8283237448515483E-03 2.4355256479577553E-05 4.5913203590448022E-09 1.6577086468092621E-15 3.8549587670984920E-23 1.9049148653561045E-32 1.9712903099182150E-43 2.7510314118032669E-56 2.7002371686045337E-70 0.0000000000000000E+00 1.7224579010285140E-87 --- ---
- 79: 3.7417875542041018E+32 3.5780413771715097E+07 1.0641653382371132E+02 1.6111547674379592E+09 4.9145875939361501E+08 9.1423948781882648E+26 1.4893012591719864E+18 8.8503715925789161E-01 0.0000000000000000E+00 1.3741968781432117E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6077831138908856E-12 4.9646900200899013E-01 0.0000000000000000E+00 4.9768103172575984E-01 5.8256209916586607E-03 2.4340686409155441E-05 4.5855643651564392E-09 1.6547369593161299E-15 3.8455627569035386E-23 1.8990439090754124E-32 1.9637397777137707E-43 2.7380616338130978E-56 2.6846464124831992E-70 0.0000000000000000E+00 1.7102936976527969E-87 --- ---
- 80: 3.8964939972735609E+32 3.6376336624364451E+07 1.0815824275302946E+02 1.5871014254707952E+09 4.8709704621150517E+08 8.9596996505507116E+26 1.4807874794690294E+18 8.8529617299903041E-01 0.0000000000000000E+00 1.3741955450487952E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4414465463911492E-12 4.9647069728918236E-01 0.0000000000000000E+00 4.9768214838669994E-01 5.8228241329202684E-03 2.4325610129532036E-05 4.5796163825000268E-09 1.6516651635817558E-15 3.8358475262870515E-23 1.8929688988138891E-32 1.9559148008739694E-43 2.7245737797799636E-56 2.6683371212879534E-70 0.0000000000000000E+00 1.6974906109227227E-87 --- ---
- 81: 4.0592167942119814E+32 3.6992231352018215E+07 1.0995683806048146E+02 1.5622903680154622E+09 4.8257102595787621E+08 8.7722299548403864E+26 1.4719160771769702E+18 8.8556825460282829E-01 0.0000000000000000E+00 1.3741941676173004E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2862462082324590E-12 4.9647244896023884E-01 0.0000000000000000E+00 4.9768330217774898E-01 5.8199342529371674E-03 2.4310034298824647E-05 4.5734798435308104E-09 1.6484950227221519E-15 3.8258185249641663E-23 1.8866929049684308E-32 1.9478183583934487E-43 2.7105690063810419E-56 2.6513023690237367E-70 0.0000000000000000E+00 1.6840364046087736E-87 --- ---
- 82: 4.2300776145254535E+32 3.7627806819006346E+07 1.1181129412394813E+02 1.5367529420598452E+09 4.7788337788359916E+08 8.5803229529964338E+26 1.4626876154884298E+18 8.8585366833393742E-01 0.0000000000000000E+00 1.3741927464071143E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1423998807276265E-12 4.9647425631296066E-01 0.0000000000000000E+00 4.9768449263051706E-01 5.8169525220692301E-03 2.4293966142156525E-05 4.5671584732160271E-09 1.6452284693994153E-15 3.8154817909204113E-23 1.8802194033696801E-32 1.9394540233917298E-43 2.6960497124101994E-56 2.6335371287067600E-70 0.0000000000000000E+00 1.6699206530482278E-87 --- ---
- 83: 4.4091755965041985E+32 3.8282741770942166E+07 1.1372049021098255E+02 1.5105239508576534E+09 4.7303736860381973E+08 8.3843412130922173E+26 1.4531036146829494E+18 8.8615266127747072E-01 0.0000000000000000E+00 1.3741912820077316E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0099609706214212E-12 4.9647611859863466E-01 0.0000000000000000E+00 4.9768571925051819E-01 5.8138801758276046E-03 2.4277413343406952E-05 4.5606562525211281E-09 1.6418675895010771E-15 3.8048439065890117E-23 1.8735522553770901E-32 1.9308259549778544E-43 2.6810195890611365E-56 2.6150384640335172E-70 0.0000000000000000E+00 1.6551349998325680E-87 --- ---
- 84: 4.5965857198159911E+32 3.8956687730314910E+07 1.1568321940203239E+02 1.4836414696615601E+09 4.6803684296357989E+08 8.1846702940255514E+26 1.4431665548567660E+18 8.8646546193708498E-01 0.0000000000000000E+00 1.3741897750303595E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 8.8882962167646983E-13 4.9647803504098842E-01 0.0000000000000000E+00 4.9768698152503765E-01 5.8107184951531402E-03 2.4260383944588591E-05 4.5539773841988667E-09 1.6384146070133826E-15 3.7939119583915916E-23 1.8666956898616243E-32 1.9219388923498315E-43 2.6654836744187283E-56 2.5958057281577722E-70 0.0000000000000000E+00 1.6396734242274601E-87 --- ---
- 85: 4.7923572693506620E+32 3.9649271660466582E+07 1.1769819664044802E+02 1.4561466375519254E+09 4.6288621189385891E+08 7.9817161281067760E+26 1.4328798753290988E+18 8.8679227873002420E-01 0.0000000000000000E+00 1.3741882260992702E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.7876777552743503E-13 4.9648000484718496E-01 0.0000000000000000E+00 4.9768827893036793E-01 5.8074687882770093E-03 2.4242886255025591E-05 4.5471262617517258E-09 1.6348718704817003E-15 3.7826935007803233E-23 1.8596542876639992E-32 1.9127981516133612E-43 2.6494484119985043E-56 2.5758407674015855E-70 0.0000000000000000E+00 1.6235325120140914E-87 --- ---
- 86: 4.9965124080893332E+32 4.0360098366153277E+07 1.1976406615856929E+02 1.4280834275962951E+09 4.5759043739975387E+08 7.7759022327257675E+26 1.4222479709320110E+18 8.8713329837059252E-01 0.0000000000000000E+00 1.3741866358439040E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.7941743957238034E-13 4.9648202721787327E-01 0.0000000000000000E+00 4.9768961093842246E-01 5.8041323741370374E-03 2.4224928770123388E-05 4.5401074415648836E-09 1.6312418409973033E-15 3.7711965244913375E-23 1.8524329682206820E-32 1.9034096246312743E-43 2.6329217110545748E-56 2.5551481249362514E-70 0.0000000000000000E+00 1.6067117250450841E-87 --- ---
- 87: 5.2090448764490796E+32 4.1088752608992808E+07 1.2187940792818941E+02 1.3994983976635456E+09 4.5215501481563014E+08 7.5676667833588996E+26 1.4112761853615201E+18 8.8748868413392135E-01 0.0000000000000000E+00 1.3741850048917355E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.9032141631660070E-13 4.9648410135625809E-01 0.0000000000000000E+00 4.9769097702270421E-01 5.8007105674115229E-03 2.4206520099904945E-05 4.5329256184043958E-09 1.6275270817520198E-15 3.7594294290480631E-23 1.8450369782550635E-32 1.8937797794648854E-43 2.6159130067290718E-56 2.5337352397051869E-70 0.0000000000000000E+00 1.5892136638147733E-87 --- ---
- 88: 5.4299188350019514E+32 4.1834800925161123E+07 1.2404274359003426E+02 1.3704404242878036E+09 4.4658595245652682E+08 7.3574595808906002E+26 1.3999708017381420E+18 8.8785857399514989E-01 0.0000000000000000E+00 1.3741833338618900E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.1094582545290731E-13 4.9648622647622526E-01 0.0000000000000000E+00 4.9769237666365290E-01 5.7972046651084269E-03 2.4187668906751367E-05 4.5255856042108850E-09 1.6237302490686696E-15 3.7474009991342510E-23 1.8374718821697421E-32 1.8839156616187146E-43 2.5984333174409175E-56 2.5116126348586896E-70 0.0000000000000000E+00 1.5710443163790708E-87 --- ---
- 89: 5.6590678666849841E+32 4.2597793140595958E+07 1.2625254109371141E+02 1.3409604220356536E+09 4.4088974879524380E+08 7.1457389465991104E+26 1.3883390304994836E+18 8.8824307864143059E-01 0.0000000000000000E+00 1.3741816233595211E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.4070393709831665E-13 4.9648840180949161E-01 0.0000000000000000E+00 4.9769380935334862E-01 5.7936159347641769E-03 2.4168383852365884E-05 4.5180923103485654E-09 1.6198540849396610E-15 3.7351203848545169E-23 1.8297435540301814E-32 1.8738248956273652E-43 2.5804952974502140E-56 2.4887940905251495E-70 0.0000000000000000E+00 1.5522132872883344E-87 --- ---
- 90: 5.8963941536053810E+32 4.3377263585656285E+07 1.2850721878012757E+02 1.3111110508767941E+09 4.3507336728841293E+08 6.9329685781985843E+26 1.3763889947154378E+18 8.8864227935823115E-01 0.0000000000000000E+00 1.3741798739708162E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.7898112516954911E-13 4.9649062661196253E-01 0.0000000000000000E+00 4.9769527459969504E-01 5.7899456039505765E-03 2.4148673552048479E-05 4.5104507327014962E-09 1.6159014107166210E-15 3.7225970846716511E-23 1.8218581702649652E-32 1.8635156855305682E-43 2.5621132807645862E-56 2.4652967934320165E-70 0.0000000000000000E+00 1.5327339982137333E-87 --- ---
- 91: 6.1417678423078713E+32 4.4172732016700014E+07 1.3080514865064524E+02 1.2809464140969777E+09 4.2914420897755426E+08 6.7196144000652281E+26 1.3641297129028851E+18 8.8905622579287469E-01 0.0000000000000000E+00 1.3741780862587385E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.2516118767355251E-13 4.9649290016914871E-01 0.0000000000000000E+00 4.9769677192998141E-01 5.7861948513316872E-03 2.4128546537293663E-05 4.5026659401179719E-09 1.6118751221768816E-15 3.7098409316645482E-23 1.8138222033856955E-32 1.8529968143325563E-43 2.5433033153226241E-56 2.4411414593835812E-70 0.0000000000000000E+00 1.5126238547806494E-87 --- ---
- 92: 6.3950266099171614E+32 4.4983704256458446E+07 1.3314465858828294E+02 1.2505217493177261E+09 4.2311008299617648E+08 6.5061414401731897E+26 1.3515710793917184E+18 8.8948493360420056E-01 0.0000000000000000E+00 1.3741762607593246E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7865481189493392E-13 4.9649522180088002E-01 0.0000000000000000E+00 4.9769830089398143E-01 5.7823647988826578E-03 2.4108011224358720E-05 4.4947430653554292E-09 1.6077781855051512E-15 3.6968620815838324E-23 1.8056424156819309E-32 1.8422776408086744E-43 2.5240831833734130E-56 2.4163524208402334E-70 0.0000000000000000E+00 1.4919043710501101E-87 --- ---
- 93: 6.6559754419100693E+32 4.5809672568518266E+07 1.3552403415422307E+02 1.2198931152030437E+09 4.1697917511448890E+08 6.2930107653535966E+26 1.3387238422818757E+18 8.8992838200841040E-01 0.0000000000000000E+00 1.3741743979785651E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3893156663397674E-13 4.9649759086527490E-01 0.0000000000000000E+00 4.9769986106656167E-01 5.7784565053385240E-03 2.4087075888932577E-05 4.4866872986002254E-09 1.6036136342159994E-15 3.6836710027408899E-23 1.7973258528463325E-32 1.8313680933622594E-43 2.5044724064486855E-56 2.3909576751324722E-70 0.0000000000000000E+00 1.4706012458889136E-87 --- ---
- 94: 6.9243866304249961E+32 4.6650115783803135E+07 1.3794151957258359E+02 1.1891170764348233E+09 4.1076001446546942E+08 6.0806765052501784E+26 1.3255995790246897E+18 8.9038651123775614E-01 0.0000000000000000E+00 1.3741724983898434E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0555720404951927E-13 4.9650000676200257E-01 0.0000000000000000E+00 4.9770145204982275E-01 5.7744709608090290E-03 2.4065748646359031E-05 4.4785038833268486E-09 1.5993845668924859E-15 3.6702784673079991E-23 1.7888798372201279E-32 1.8202786603366176E-43 2.4844922329425201E-56 2.3649888886083705E-70 0.0000000000000000E+00 1.4487443854562442E-87 --- ---
- 95: 7.1999999999999965E+32 4.7504499198818624E+07 1.4039531798375776E+02 1.1582503895238993E+09 4.0446143860393631E+08 5.8695829937794394E+26 1.3122106696503117E+18 8.9085921993115846E-01 0.0000000000000000E+00 1.3741705624318376E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7823765252548486E-13 4.9650246893495409E-01 0.0000000000000000E+00 4.9770307347485149E-01 5.7704090823719294E-03 2.4044037436238251E-05 4.4701981139761503E-09 1.5950941454781131E-15 3.6566955431901282E-23 1.7803119601111760E-32 1.8090203759302778E-43 2.4641656060324262E-56 2.3384813519700192E-70 0.0000000000000000E+00 1.4263678662374374E-87 --- ---
- 96: 7.4825233654680658E+32 4.8372274266728714E+07 1.4288359143650689E+02 1.1273496919914637E+09 3.9809255705911374E+08 5.6601620550243972E+26 1.2985702676663081E+18 8.9134636248121946E-01 0.0000000000000000E+00 1.3741685905069843E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5686860669469740E-13 4.9650497687420236E-01 0.0000000000000000E+00 4.9770472500300361E-01 5.7662717108397793E-03 2.4021950012300892E-05 4.4617753356867653E-09 1.5907455942570061E-15 3.6429335869102149E-23 1.7716300734720105E-32 1.7976048020242002E-43 2.4435171119883303E-56 2.3114738854770758E-70 0.0000000000000000E+00 1.4035098362569019E-87 --- ---
- 97: 7.7716466101759362E+32 4.9252918723437890E+07 1.4540457631667786E+02 1.0964704708956230E+09 3.9166256145744139E+08 5.4528256033011321E+26 1.2846919391304689E+18 8.9184775833579677E-01 0.0000000000000000E+00 1.3741665829320519E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4158273154561746E-13 4.9650753017886423E-01 0.0000000000000000E+00 4.9770640636729052E-01 5.7620595070576866E-03 2.3999493395521649E-05 4.4532407399267939E-09 1.5863420931750863E-15 3.6290039011320784E-23 1.7628420687609072E-32 1.7860437267957493E-43 2.4225724029512497E-56 2.2840080297345966E-70 0.0000000000000000E+00 1.3802117901603075E-87 --- ---
- 98: 8.0670300945172416E+32 5.0145896777021065E+07 1.4795646959324412E+02 1.0656668324738120E+09 3.8518069255077171E+08 5.2479639626910617E+26 1.2705896285335788E+18 8.9236319006834974E-01 0.0000000000000000E+00 1.3741645399383049E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3277662799967899E-13 4.9651012855690363E-01 0.0000000000000000E+00 4.9770811737223553E-01 5.7577729522336960E-03 2.3976673885353395E-05 4.4445993763518376E-09 1.5818867828668035E-15 3.6149177455364613E-23 1.7539558776438935E-32 1.7743491514503289E-43 2.4013581255493260E-56 2.2561278660423036E-70 0.0000000000000000E+00 1.3565183518940284E-87 --- ---
- 99: 8.3683057110728352E+32 5.1050658289964095E+07 1.5053742716960656E+02 1.0349919321409327E+09 3.7865634537174022E+08 5.0459486401562602E+26 1.2562779279602371E+18 8.9289239017028588E-01 0.0000000000000000E+00 1.3741624617141099E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3108277279199496E-13 4.9651277177094827E-01 0.0000000000000000E+00 4.9770985785818289E-01 5.7534124373294108E-03 2.3953497542511428E-05 4.4358563413214126E-09 1.5773828604131307E-15 3.6006866334908944E-23 1.7449796521877091E-32 1.7625335111387751E-43 2.3799022665039508E-56 2.2278803682423022E-70 0.0000000000000000E+00 1.3324774952612961E-87 --- ---
- 100: 8.6750781544790573E+32 5.1966637847500838E+07 1.5314556223845341E+02 1.0044977140910264E+09 3.7209903110050559E+08 4.8471304883243965E+26 1.2417720423154273E+18 8.9343503851756723E-01 0.0000000000000000E+00 1.3741603484050287E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3725094489646898E-13 4.9651545963817273E-01 0.0000000000000000E+00 4.9771162770121113E-01 5.7489782632591082E-03 2.3929970193628236E-05 4.4270167828813352E-09 1.5728335800402293E-15 3.5863223269118959E-23 1.7359217537391461E-32 1.7506096417916652E-43 2.3582340284103446E-56 2.1993151182853018E-70 0.0000000000000000E+00 1.3081402080473629E-87 --- ---
- 101: 8.9869263997885493E+32 5.2893253732349947E+07 1.5577894318860311E+02 9.7423466442178595E+08 3.6551833839996868E+08 4.6518380931149419E+26 1.2270877525548360E+18 8.9399075996002186E-01 0.0000000000000000E+00 1.3741582001144284E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5193562417077853E-13 4.9651819202953196E-01 0.0000000000000000E+00 4.9771342681261960E-01 5.7444706421612641E-03 2.3906097440027616E-05 4.4180859064293667E-09 1.5682422539376170E-15 3.5718368307275731E-23 1.7267907407357382E-32 1.7385907431297735E-43 2.3363836884188376E-56 2.1704839774562075E-70 0.0000000000000000E+00 1.2835601005377030E-87 --- ---
- 102: 9.3034053808593111E+32 5.3829906826266095E+07 1.5843559163387181E+02 9.4425157954793572E+08 3.5892389443714166E+08 4.4603763960932059E+26 1.2122413769758620E+18 8.9455912208404154E-01 0.0000000000000000E+00 1.3741560169048208E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7544835523059886E-13 4.9652096886805952E-01 0.0000000000000000E+00 4.9771525513780018E-01 5.7398897002137426E-03 2.3881884672822328E-05 4.4090689815903200E-09 1.5636122534794696E-15 3.5572423879198655E-23 1.7175953562011680E-32 1.7264903391794988E-43 2.3143824434056535E-56 2.1414407201678717E-70 0.0000000000000000E+00 1.2587929659611096E-87 --- ---
- 103: 9.6240478581360333E+32 5.4775979459016532E+07 1.6111348019857900E+02 9.1459535150419950E+08 3.5232532581705260E+08 4.2730255583869364E+26 1.1972497306302118E+18 8.9513963320209633E-01 0.0000000000000000E+00 1.3741537987999262E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0758021587073801E-13 4.9652379012624476E-01 0.0000000000000000E+00 4.9771711265450547E-01 5.7352354819678250E-03 2.3857337093816357E-05 4.3999713497671152E-09 1.5589470105783880E-15 3.5425514743693186E-23 1.7083445145801359E-32 1.7143222362285382E-43 2.2922622429538994E-56 2.1122406348495360E-70 0.0000000000000000E+00 1.2338962988713278E-87 --- ---
- 104: 9.9483664631032995E+32 5.5730834225707017E+07 1.6381053044235333E+02 8.8531077155179298E+08 3.4573221966336012E+08 4.0900400698864648E+26 1.1821300829333809E+18 8.9573174062919192E-01 0.0000000000000000E+00 1.3741515457877533E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4757257072699417E-13 4.9652665582211969E-01 0.0000000000000000E+00 4.9771899937026987E-01 5.7305079568100844E-03 2.3832459744967216E-05 4.3907984330178717E-09 1.5542500194989837E-15 3.5277767946002969E-23 1.6990472887531045E-32 1.7021004797589796E-43 2.2700556146034980E-56 2.0829401011332905E-70 0.0000000000000000E+00 1.2089287819257117E-87 --- ---
- 105: 1.0275855904722873E+33 5.6693812793828577E+07 1.6652461078692221E+02 8.5644035330105066E+08 3.3915408508676034E+08 3.9116481043574957E+26 1.1669001135510185E+18 8.9633482930693698E-01 0.0000000000000000E+00 1.3741492578246993E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.9423055125064172E-13 4.9652956601403664E-01 0.0000000000000000E+00 4.9772091531897306E-01 5.7257070275849257E-03 2.3807257546044720E-05 4.3815557436948875E-09 1.5495248388228920E-15 3.5129312775022749E-23 1.6897128967954177E-32 1.6898393102446430E-43 2.2477954830099251E-56 2.0535961492717952E-70 0.0000000000000000E+00 1.1839497491215027E-87 --- ---
- 106: 1.0605995321344584E+33 5.7664234721986674E+07 1.6925353458865104E+02 8.2802417634720981E+08 3.3260031528497380E+08 3.7380511180599319E+26 1.1515778666531011E+18 8.9694822084084147E-01 0.0000000000000000E+00 1.3741469348410011E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.4610825063184434E-13 4.9653252079373456E-01 0.0000000000000000E+00 4.9772286055628029E-01 5.7208325420374309E-03 2.3781735343365190E-05 4.3722488954368765E-09 1.5447750938370316E-15 3.4980280729094725E-23 1.6803506891768047E-32 1.6775531192031275E-43 2.2255149875122926E-56 2.0242660118348766E-70 0.0000000000000000E+00 1.1590186373599080E-87 --- ---
- 107: 1.0938250759929178E+33 5.8641396313007079E+07 1.7199505849206585E+02 8.0009975118986344E+08 3.2608015051783282E+08 3.5694236865410223E+26 1.1361817036333354E+18 8.9757117301656519E-01 0.0000000000000000E+00 1.3741445767477504E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0168890900813606E-13 4.9653552027740844E-01 0.0000000000000000E+00 4.9772483515377286E-01 5.7158843075525399E-03 2.3755897971423939E-05 4.3628836156604415E-09 1.5400044793736947E-15 3.4830805491270375E-23 1.6709701365846730E-32 1.6652564062174772E-43 2.2032473014478358E-56 1.9950066764059604E-70 0.0000000000000000E+00 1.1341944372732669E-87 --- ---
- 108: 1.1272077762965457E+33 5.9624569524975702E+07 1.7474688104128813E+02 7.7270190597396231E+08 3.1960264220253944E+08 3.4059135715131239E+26 1.1207302543967762E+18 8.9820287986152858E-01 0.0000000000000000E+00 1.3741421834455831E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.5951673070433320E-13 4.9653856459464862E-01 0.0000000000000000E+00 4.9772683919168081E-01 5.7108621094079885E-03 2.3729750327821809E-05 4.3534657591459513E-09 1.5352167628374500E-15 3.4681022905458339E-23 1.6615808179454001E-32 1.6529637368292511E-43 2.1810254550801434E-56 1.9658744461416833E-70 0.0000000000000000E+00 1.1095351527612232E-87 --- ---
- 109: 1.1606924042224911E+33 6.0613000964745224E+07 1.7750664149398679E+02 7.4586269535254204E+08 3.1317661836517370E+08 3.2476420071643711E+26 1.1052423673266720E+18 8.9884247231615000E-01 0.0000000000000000E+00 1.3741397548355465E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.1827256378707247E-13 4.9654165387460381E-01 0.0000000000000000E+00 4.9772887274979427E-01 5.7057657336066544E-03 2.3703297466245517E-05 4.3440013238730242E-09 1.5304157879370393E-15 3.4531070969164457E-23 1.6521924097236716E-32 1.6406897031513305E-43 2.1588821674755813E-56 1.9369245195528535E-70 0.0000000000000000E+00 1.0850972824703513E-87 --- ---
- 110: 1.1942232217492810E+33 6.1605910989498816E+07 1.8027191933989749E+02 7.1961133153492498E+08 3.0681065068103045E+08 3.0947041929423795E+26 1.0897370580428800E+18 8.9948901957744953E-01 0.0000000000000000E+00 1.3741372908321461E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.7680566710928116E-13 4.9654478822937304E-01 0.0000000000000000E+00 4.9773093589655726E-01 5.7005949942803965E-03 2.3676544706599675E-05 4.3344964681891958E-09 1.5256054785744120E-15 3.4381089824857712E-23 1.6428146754448310E-32 1.6284488862079866E-43 2.1368496873947646E-56 1.9082105937372359E-70 0.0000000000000000E+00 1.0609353302579606E-87 --- ---
- 111: 1.2277442597660631E+33 6.2602492943064086E+07 1.8304023398510225E+02 6.9397413735031140E+08 3.0051302332207423E+08 2.9471699778142286E+26 1.0742334570713673E+18 9.0014153117011975E-01 0.0000000000000000E+00 1.3741347913790904E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.3413874212185939E-13 4.9654796773395832E-01 0.0000000000000000E+00 4.9773302867590419E-01 5.6953497667691314E-03 2.3649497767164154E-05 4.3249575304841115E-09 1.5207898433990822E-15 3.4231221764846131E-23 1.6334574564234384E-32 1.6162558216287258E-43 2.1149596478287100E-56 1.8797845009536962E-70 0.0000000000000000E+00 1.0371013562259293E-87 --- ---
- 112: 1.2611995981071659E+33 6.3601912554769404E+07 1.8580904531156261E+02 6.6897452093063283E+08 2.9429170381869024E+08 2.8050847192795734E+26 1.0587507565445605E+18 9.0079895979408720E-01 0.0000000000000000E+00 1.3741322564678185E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.8946027384037531E-13 4.9655119240267570E-01 0.0000000000000000E+00 4.9773515109177446E-01 5.6900300265409157E-03 2.3622162918779753E-05 4.3153910508074605E-09 1.5159729806512223E-15 3.4081611236705511E-23 1.6241306629137653E-32 1.6041249679489217E-43 2.0932429342950849E-56 1.8516958820661625E-70 0.0000000000000000E+00 1.0136445741780530E-87 --- ---
- 113: 1.2945336451787247E+33 6.4603307529673107E+07 1.8857575455192770E+02 6.4463297140094900E+08 2.8815431612466305E+08 2.6684702990113500E+26 1.0433081560565364E+18 9.0146020498739154E-01 0.0000000000000000E+00 1.3741296861591474E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.4211280356823144E-13 4.9655446216158683E-01 0.0000000000000000E+00 4.9773730309001568E-01 5.6846358946778548E-03 2.3594547164026915E-05 4.3058037949788831E-09 1.5111590834824135E-15 3.3932404853904070E-23 1.6148442659800993E-32 1.5920706781213977E-43 2.0717295691892118E-56 1.8239919027022340E-70 0.0000000000000000E+00 9.9061100288281565E-88 --- ---
- 114: 1.3276914148488799E+33 6.5605787359906465E+07 1.9133770618159693E+02 6.2096707476304567E+08 2.8210811605587029E+08 2.5373262759303295E+26 1.0279248077984349E+18 9.0212411763050504E-01 0.0000000000000000E+00 1.3741270806081838E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.9158111117416032E-13 4.9655777681678048E-01 0.0000000000000000E+00 4.9773948453756467E-01 5.6791676902087623E-03 2.3566658442167493E-05 4.2962027810354065E-09 1.5063524455949349E-15 3.3783751405439029E-23 1.6056082896901357E-32 1.5801071738697032E-43 2.0504486124445703E-56 1.7967170147029342E-70 0.0000000000000000E+00 9.6804317527634711E-88 --- ---
- 115: 1.3606187983049275E+33 6.6608433387574382E+07 1.9409219028046684E+02 5.9799154897322381E+08 2.7615996925020534E+08 2.4116311568019151E+26 1.0126197611015082E+18 9.0278950530353042E-01 0.0000000000000000E+00 1.3741244400926004E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 8.3748132929914445E-13 4.9656113601836183E-01 0.0000000000000000E+00 4.9774169519881367E-01 5.6736259895218176E-03 2.3538505860545080E-05 4.2865953079598017E-09 1.5015574671061223E-15 3.3635801860540121E-23 1.5964328033636405E-32 1.5682485226194487E-43 2.0294280786541630E-56 1.7699127646652394E-70 0.0000000000000000E+00 9.4597990856153243E-88 --- ---
- 116: 1.3932628286393314E+33 6.7610299150068551E+07 1.9683644601580349E+02 5.7571829704782128E+08 2.7031633177143461E+08 2.2913437640553541E+26 9.9741190651813274E+17 9.0345513849016312E-01 0.0000000000000000E+00 1.3741217650443659E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 8.7955060481487402E-13 4.9656453922004701E-01 0.0000000000000000E+00 4.9774393470909289E-01 5.6680116930290418E-03 2.3510099953040423E-05 4.2769889867527197E-09 1.4967786606265696E-15 3.3488709367350918E-23 1.5873279137794521E-32 1.5565086169052953E-43 2.0086948707888898E-56 1.7436176506814403E-70 0.0000000000000000E+00 9.2445613700896225E-88 --- ---
- 117: 1.4255719360108027E+33 6.8610411038667217E+07 1.9956766580781559E+02 5.5415647688510609E+08 2.6458323345519975E+08 2.1764046804758649E+26 9.8231991957314547E+17 9.0411975760443986E-01 0.0000000000000000E+00 1.3741190560847130E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.1763656348909289E-13 4.9656798563462867E-01 0.0000000000000000E+00 4.9774620254544577E-01 5.6623260986432503E-03 2.3481452963353679E-05 4.2673917731458604E-09 1.4920206571898696E-15 3.3342629234153351E-23 1.5783037566033360E-32 1.5449011552713410E-43 1.9882747287998448E-56 1.7178670253514829E-70 0.0000000000000000E+00 9.0350280619867547E-88 --- ---
- 118: 1.4574961913354622E+33 6.9607769300821811E+07 2.0228300051389752E+02 5.3331258636872315E+08 2.5896626406281102E+08 2.0667377506769615E+26 9.6736220432288550E+17 9.0478208079335620E-01 0.0000000000000000E+00 1.3741163140621914E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.5168601277667180E-13 4.9657147418551517E-01 0.0000000000000000E+00 4.9774849799482873E-01 5.6565709817309792E-03 2.3452579151767619E-05 4.2578120018081742E-09 1.4872882119897234E-15 3.3197718892215207E-23 1.5693704869620182E-32 1.5334396245001187E-43 1.9681921925797825E-56 1.6926930440347715E-70 0.0000000000000000E+00 8.8314682763268332E-88 --- ---
- 119: 1.4889875365948238E+33 7.0601349415451616E+07 2.0497956567732427E+02 5.1319056221912730E+08 2.5347056228341749E+08 1.9622516198138314E+26 9.5255683686388096E+17 9.0544081244870489E-01 0.0000000000000000E+00 1.3741135400932983E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8173268887974012E-13 4.9657500345497674E-01 0.0000000000000000E+00 4.9775082012015215E-01 5.6507486805003468E-03 2.3423495120890961E-05 4.2482584211176066E-09 1.4825862095405011E-15 3.3054137829718820E-23 1.5605382685103681E-32 1.5221372822293723E-43 1.9484705771492418E-56 1.6681246546741804E-70 0.0000000000000000E+00 8.6341108997038171E-88 --- ---
- 120: 1.5199999999999995E+33 7.1590103868772000E+07 2.0765444876334112E+02 4.9379189098418611E+08 2.4810080759161240E+08 1.8628412908110437E+26 9.3792150894071590E+17 9.0609465233734721E-01 0.0000000000000000E+00 1.3741107356049918E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0078842006569776E-12 4.9657857163000507E-01 0.0000000000000000E+00 4.9775316772475714E-01 5.6448621853260311E-03 2.3394220154074915E-05 4.2387402273145410E-09 1.4779196678101421E-15 3.2912047485264040E-23 1.5518172603093025E-32 1.5110071389679978E-43 1.9291319576668856E-56 1.6441876247015208E-70 0.0000000000000000E+00 8.4431452202774267E-88 --- ---
- 121: 1.5504898944229376E+33 7.2572964355557203E+07 2.1030471743888700E+02 4.7511573051024449E+08 2.4286121493700257E+08 1.7683896824274080E+26 9.2347347181208589E+17 9.0674230523798549E-01 0.0000000000000000E+00 1.3741079023782657E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0303085571093452E-12 4.9658217644680691E-01 0.0000000000000000E+00 4.9775553931599859E-01 5.6389152303276385E-03 2.3364776559783876E-05 4.2292670970814439E-09 1.4732937410508831E-15 3.2771611096026342E-23 1.5432176012730534E-32 1.5000619390871379E-43 1.9101971626992997E-56 1.6209046011468103E-70 0.0000000000000000E+00 8.2587220277518524E-88 --- ---
- 122: 1.5804674455118365E+33 7.3550532404884294E+07 2.1293195759034950E+02 4.5714364678457606E+08 2.3775112297673407E+08 1.6786928545279225E+26 9.0921711514550605E+17 9.0738304678584281E-01 0.0000000000000000E+00 1.3741050400616931E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0492375060842980E-12 4.9658581835442339E-01 0.0000000000000000E+00 4.9775793518657019E-01 5.6329070742688822E-03 2.3335163837850390E-05 4.2198408852599306E-09 1.4687096690094696E-15 3.2632870858814071E-23 1.5347419000439443E-32 1.4893046316941302E-43 1.8916693968773407E-56 1.5982751968098607E-70 0.0000000000000000E+00 8.0807978559281802E-88 --- ---
- 123: 1.6099426589457796E+33 7.4523383402418330E+07 2.1553766383138370E+02 4.3984269718359548E+08 2.3276555336254424E+08 1.5934809445897140E+26 8.9514477170095450E+17 9.0801669920461314E-01 0.0000000000000000E+00 1.3741021461240841E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0649365434077390E-12 4.9658950057531104E-01 0.0000000000000000E+00 4.9776035745380837E-01 5.6268324005618389E-03 2.3305358788051672E-05 4.2104561194518394E-09 1.4641651057722483E-15 3.2495759921195260E-23 1.5263860686941892E-32 1.4787295905753294E-43 1.8735368084301551E-56 1.5762800222057155E-70 0.0000000000000000E+00 7.9091745000327901E-88 --- ---
- 124: 1.6389253255361677E+33 7.5492070027512893E+07 2.1812324848185480E+02 4.2318194536164713E+08 2.2789977989631078E+08 1.5125025451776224E+26 8.8124911912379827E+17 9.0864307776957409E-01 0.0000000000000000E+00 1.3740992182121737E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0776755760433035E-12 4.9659322610561302E-01 0.0000000000000000E+00 4.9776280808613271E-01 5.6206862659862016E-03 2.3275340072777091E-05 4.2011079485840293E-09 1.4596580106594085E-15 3.2360220733366372E-23 1.5181465835082135E-32 1.4683318811855677E-43 1.8557886067817868E-56 1.5549006785501536E-70 0.0000000000000000E+00 7.7436588858217096E-88 --- ---
- 125: 1.6674250262022876E+33 7.6457125363056079E+07 2.2069005045018582E+02 4.0713230209592307E+08 2.2314930822883353E+08 1.4355231580452015E+26 8.6752314802097958E+17 9.0926199142609909E-01 0.0000000000000000E+00 1.3740962541798087E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0877228669680714E-12 4.9659699767799292E-01 0.0000000000000000E+00 4.9776528887864646E-01 5.6144641620050721E-03 2.3245088465625571E-05 4.1917921808475134E-09 1.4551866596609662E-15 3.2226205252734196E-23 1.5100204931528655E-32 1.4581072697241164E-43 1.8384150892541948E-56 1.5341198238026157E-70 0.0000000000000000E+00 7.5840638844916056E-88 --- ---
- 126: 1.6954511368242891E+33 7.7419065730436340E+07 2.2323934215879765E+02 3.9166638218352139E+08 2.1850985757238275E+08 1.3623238067170559E+26 8.5396013306626534E+17 9.0987324336259956E-01 0.0000000000000000E+00 1.3740932521246174E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0953403180431516E-12 4.9660081771494352E-01 0.0000000000000000E+00 4.9776780142247917E-01 5.6081620917976943E-03 2.3214587168786359E-05 4.1825053374576172E-09 1.4507496633687244E-15 3.2093675319818189E-23 1.5020054360976221E-32 1.4480522421495300E-43 1.8214076798935073E-56 1.5139212442867954E-70 0.0000000000000000E+00 7.4302090958173851E-88 --- ---
- 127: 1.7230128329767566E+33 7.8378393294466659E+07 2.2577233656533303E+02 3.7675837541152602E+08 2.1397734416628265E+08 1.2926997880493343E+26 8.4055360671529331E+17 9.1047663154474556E-01 0.0000000000000000E+00 1.3740902104332688E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1007799236484519E-12 4.9660468827115539E-01 0.0000000000000000E+00 4.9777034706694068E-01 5.6017766653389967E-03 2.3183822208996892E-05 4.1732447240811548E-09 1.4463459920840380E-15 3.1962603221650273E-23 1.4940996681245029E-32 1.4381640340955277E-43 1.8047589820995734E-56 1.4942899342309360E-70 0.0000000000000000E+00 7.2819216206507468E-88 --- ---
- 128: 1.7501190945459738E+33 7.9335598477019370E+07 2.2829019290968245E+02 3.6238392990840423E+08 2.0954786627552834E+08 1.2264595460768304E+26 8.2729733517064845E+17 9.1107194921902002E-01 0.0000000000000000E+00 1.3740871278365271E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1042812332783601E-12 4.9660861096342240E-01 0.0000000000000000E+00 4.9777292687348773E-01 5.5953052150440521E-03 2.3152782922575459E-05 4.1640085218438377E-09 1.4419750087828589E-15 3.1832972458251678E-23 1.4863021007011053E-32 1.4284406725263123E-43 1.7884628464303890E-56 1.4752121850336207E-70 0.0000000000000000E+00 7.1390368384485962E-88 --- ---
- 129: 1.7767787102338976E+33 8.0291162213220656E+07 2.3079402214215747E+02 3.4852004642381215E+08 2.0521769052980739E+08 1.1634236537994683E+26 8.1418529628542707E+17 9.1165898539053580E-01 0.0000000000000000E+00 1.3740840034758305E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1060696695484920E-12 4.9661258688586818E-01 0.0000000000000000E+00 4.9777554156004555E-01 5.5887459356286162E-03 2.3121462545256374E-05 4.1547959012404947E-09 1.4376365112559477E-15 3.1704778745992379E-23 1.4786123520571162E-32 1.4188810312623308E-43 1.7725144570315343E-56 1.4566756883474618E-70 0.0000000000000000E+00 7.0013992214291653E-88 --- ---
- 130: 1.8030002819517733E+33 8.1245558080118924E+07 2.3328489187714570E+02 3.3514498228545493E+08 2.0098323944099998E+08 1.1034238905355170E+26 8.0121165913374502E+17 9.1223752528232704E-01 0.0000000000000000E+00 1.3740808369829756E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1063555608409225E-12 4.9661661650848810E-01 0.0000000000000000E+00 4.9777819143436935E-01 5.5820980514980417E-03 2.3089858920653869E-05 4.1456071615022583E-09 1.4333307843372825E-15 3.1578031278750966E-23 1.4710308119903691E-32 1.4094849014424347E-43 1.7569104382423841E-56 1.4386696546600059E-70 0.0000000000000000E+00 6.8688631972926660E-88 --- ---
- 131: 1.8287922291062446E+33 8.2199254324617550E+07 2.3576383070898009E+02 3.2223816394973260E+08 1.9684107995619640E+08 1.0463024041258370E+26 7.8837076500981222E+17 9.1280735078008324E-01 0.0000000000000000E+00 1.3740776285753439E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1053337610668951E-12 4.9662069955590249E-01 0.0000000000000000E+00 4.9778087631440615E-01 5.5753620167822400E-03 2.3057975349561278E-05 4.1364439002642725E-09 1.4290586641759226E-15 3.1452754297828612E-23 1.4635587231972731E-32 1.4002530801475287E-43 1.7416489864484704E-56 1.4211849530049810E-70 0.0000000000000000E+00 6.7412941007053872E-88 --- ---
- 132: 1.8541627927807330E+33 8.3152715815020472E+07 2.3823183229012102E+02 3.0978010720637763E+08 1.9278791292389312E+08 9.9191094868280047E+25 7.7565710964400563E+17 9.1336824086858914E-01 0.0000000000000000E+00 1.3740743791690674E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1031837447178846E-12 4.9662483486327091E-01 0.0000000000000000E+00 4.9778359543365058E-01 5.5685397530540756E-03 2.3025821601572933E-05 4.1273092179163636E-09 1.4248216162389743E-15 3.1328989012581660E-23 1.4561982813363897E-32 1.3911874796245708E-43 1.7267300308114842E-56 1.4042142755568919E-70 0.0000000000000000E+00 6.6185692380266599E-88 --- ---
- 133: 1.8791200398147914E+33 8.4106405938686311E+07 2.4068985901652843E+02 2.9775234421815360E+08 1.8882056336485854E+08 9.4011018977099754E+25 7.6306532644664666E+17 9.1391997206394582E-01 0.0000000000000000E+00 1.3740710905134355E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1000700807388715E-12 4.9662902020515698E-01 0.0000000000000000E+00 4.9778634732873345E-01 5.5616349316717833E-03 2.2993415119231139E-05 4.1182079633045005E-09 1.4206218297536031E-15 3.1206795942686737E-23 1.4489527577188919E-32 1.3822912615816214E-43 1.7121554297621084E-56 1.3877523344197782E-70 0.0000000000000000E+00 6.5005791142838051E-88 --- ---
- 134: 1.9036718667840526E+33 8.5060788466949359E+07 2.4313884536353581E+02 2.8613735668019575E+08 1.8493597145625156E+08 8.9076906992766085E+25 7.5059017060821018E+17 9.1446231884739160E-01 0.0000000000000000E+00 1.3740677653500564E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0961432039990794E-12 4.9663325209287629E-01 0.0000000000000000E+00 4.9778912970630296E-01 5.5546533081206242E-03 2.2960782446587513E-05 4.1091470276570347E-09 1.4164623313349585E-15 3.1086257752855667E-23 1.4418266484604966E-32 1.3735690008863589E-43 1.6979292097712125E-56 1.3717960972629792E-70 0.0000000000000000E+00 6.3872288645824808E-88 --- ---
- 135: 1.9278260038833399E+33 8.6016329407595679E+07 2.4557970119677375E+02 2.7491851447152913E+08 1.8113118414497286E+08 8.4376422830227170E+25 7.3822650389853875E+17 9.1499505410624971E-01 0.0000000000000000E+00 1.3740644076013721E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0915404179490465E-12 4.9663752553446772E-01 0.0000000000000000E+00 4.9779193928535165E-01 5.5476031180183728E-03 2.2927960924494861E-05 4.1001356962966302E-09 1.4123471217361265E-15 3.0967482684314003E-23 1.4348258558678880E-32 1.3650268853223805E-43 1.6840578565935222E-56 1.3563450724029031E-70 0.0000000000000000E+00 6.2784399586026093E-88 --- ---
- 136: 1.9515900187154163E+33 8.6973498864740774E+07 2.4801331463465161E+02 2.6408001924766088E+08 1.7740334732365632E+08 7.9897946894766593E+25 7.2596928001931494E+17 9.1551794958802379E-01 0.0000000000000000E+00 1.3740610225936328E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0863870756597392E-12 4.9664183375079152E-01 0.0000000000000000E+00 4.9779477161072033E-01 5.5404955455054979E-03 2.2895000699525971E-05 4.0911860686972338E-09 1.4082813400566333E-15 3.0850608697680713E-23 1.4279579083868254E-32 1.3566729586656547E-43 1.6705506700122273E-56 1.3414016545941098E-70 0.0000000000000000E+00 6.1741522491249908E-88 --- ---
- 137: 1.9749713199878009E+33 8.7932772925929099E+07 2.5044055480820597E+02 2.5360685248757288E+08 1.7374969850647122E+08 7.5630527293829048E+25 7.1381353037151360E+17 9.1603077637578678E-01 0.0000000000000000E+00 1.3740576173209103E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0807978999976291E-12 4.9664616783937132E-01 0.0000000000000000E+00 4.9779762083226964E-01 5.5333452778461760E-03 2.2861967107585363E-05 4.0823135611143855E-09 1.4042714613739596E-15 3.0735808487809873E-23 1.4212322280986350E-32 1.3485174175276459E-43 1.6574201981419169E-56 1.3269715481430320E-70 0.0000000000000000E+00 6.0743264709156918E-88 --- ---
- 138: 1.9979771611200066E+33 8.8894635596654087E+07 2.5286227446932594E+02 2.4348472756546319E+08 1.7016755995807740E+08 7.1563835005371264E+25 7.0175435010574963E+17 9.1653330539325950E-01 0.0000000000000000E+00 1.3740542007579677E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0748784162717879E-12 4.9665051637603053E-01 0.0000000000000000E+00 4.9780047944318118E-01 5.5261711626599635E-03 2.2828943505003491E-05 4.0735375089625354E-09 1.4003255350487710E-15 3.0623295566949770E-23 1.4146604568013790E-32 1.3405729748321868E-43 1.6446827710821871E-56 1.3130642877592379E-70 0.0000000000000000E+00 5.9789473197533219E-88 --- ---
- 139: 2.0206146437634887E+33 8.9859580803294271E+07 2.5527931252762997E+02 2.3370004546585497E+08 1.6665433223783246E+08 6.7688122624866180E+25 6.8978688432576243E+17 9.1702530795190851E-01 0.0000000000000000E+00 1.3740507842319303E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0687264836898288E-12 4.9665486494166561E-01 0.0000000000000000E+00 4.9780333796907184E-01 5.5189969886608441E-03 2.2796034640284066E-05 4.0648818914200814E-09 1.3964534733158398E-15 3.0513331679300717E-23 1.4082568555789799E-32 1.3328553074198337E-43 1.6323591609926861E-56 1.2996938852233472E-70 0.0000000000000000E+00 5.8880272912098699E-88 --- ---
- 140: 2.0428907212365411E+33 9.0828114486696512E+07 2.5769249663716226E+02 2.2423985380326575E+08 1.6320748813984153E+08 6.3994186355416753E+25 6.7790631431637043E+17 9.1750655635567813E-01 0.0000000000000000E+00 1.3740473818654506E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0624339255430721E-12 4.9665919555799287E-01 0.0000000000000000E+00 4.9780618459729670E-01 5.5118524165747793E-03 2.2763370686197929E-05 4.0563762076668021E-09 1.3926674028571547E-15 3.0406235897287730E-23 1.4020387978192665E-32 1.3253836113244206E-43 1.6204754051691089E-56 1.2868796399324541E-70 0.0000000000000000E+00 5.8016115233390060E-88 --- ---
- 141: 2.0648122018763024E+33 9.1800756810351640E+07 2.6010264539271810E+02 2.1509180884428647E+08 1.5982456703030977E+08 6.0473330942206699E+25 6.6610784366507520E+17 9.1797682458550178E-01 0.0000000000000000E+00 1.3740440111085109E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0560882742729062E-12 4.9666348601044241E-01 0.0000000000000000E+00 4.9780900473209616E-01 5.5047740962432135E-03 2.2731112094691395E-05 4.0480565453558754E-09 1.3889820970493072E-15 3.0302395891321821E-23 1.3960273838521212E-32 1.3181812981028616E-43 1.6090638441963053E-56 1.2746471677317404E-70 0.0000000000000000E+00 5.7197839939324270E-88 --- ---
- 142: 2.0863857523099949E+33 9.2778044509355024E+07 2.6251057086413294E+02 2.0624414026211476E+08 1.5650316961955410E+08 5.7117337284794750E+25 6.5438668414197274E+17 9.1843588909548701E-01 0.0000000000000000E+00 1.3740406933831725E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0497746688127506E-12 4.9666770902727020E-01 0.0000000000000000E+00 4.9781178045526037E-01 5.4978070209360857E-03 2.2699455505723134E-05 4.0399668997766442E-09 1.3854155145171331E-15 3.0202282089100006E-23 1.3902482183736822E-32 1.3112768811457659E-43 1.5981644517172093E-56 1.2630297282166889E-70 0.0000000000000000E+00 5.6426755907132245E-88 --- ---
- 143: 2.1076179006474449E+33 9.3760533409201145E+07 2.6491708127823006E+02 1.9768561838148671E+08 1.5324095326673794E+08 5.3918432489007104E+25 6.4273804119593702E+17 9.1888352976979248E-01 0.0000000000000000E+00 1.3740374548779386E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0435779729563272E-12 4.9667183126819930E-01 0.0000000000000000E+00 4.9781448986162025E-01 5.4910061959055198E-03 2.2668641059641969E-05 4.0321608326800913E-09 1.3819894831294478E-15 3.0106465820478607E-23 1.3847324137807624E-32 1.3047051271096060E-43 1.5878265735287680E-56 1.2520699740066032E-70 0.0000000000000000E+00 5.5704748542548732E-88 --- ---
- 144: 2.1285150395968905E+33 9.4748801147024855E+07 2.6732298341303596E+02 1.8940552369648129E+08 1.5003562803452933E+08 5.0869262145131620E+25 6.3115709891483315E+17 9.1931953112069986E-01 0.0000000000000000E+00 1.3740343275511007E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0375852349873025E-12 4.9667581204702749E-01 0.0000000000000000E+00 4.9781710621970221E-01 5.4844387458393411E-03 2.2638961678877854E-05 4.0247036147498672E-09 1.3787305927702680E-15 3.0015643221648805E-23 1.3795179215715439E-32 1.2985085940759674E-43 1.5781112665121421E-56 1.2418223218810207E-70 0.0000000000000000E+00 5.5034426882928987E-88 --- ---
- 145: 2.1490834295060223E+33 9.5743450132304668E+07 2.6972908568873885E+02 1.8139361846439886E+08 1.4688495393556312E+08 4.7962864640934104E+25 6.1963900428514893E+17 9.1974368386480077E-01 0.0000000000000000E+00 1.3740313504493288E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0318887072410329E-12 4.9667960165294744E-01 0.0000000000000000E+00 4.9781959686864791E-01 5.4781866843567530E-03 2.2610775329928957E-05 4.0176751076443365E-09 1.3756714091523550E-15 2.9930668036050151E-23 1.3746513722354988E-32 1.2927397709381394E-43 1.5690945730526638E-56 1.2323562975820274E-70 0.0000000000000000E+00 5.4419333133296407E-88 --- ---
- 146: 2.1693292013301543E+33 9.6745110789449751E+07 2.7213620112492492E+02 1.7364012019700843E+08 1.4378674033317986E+08 4.5192647337580417E+25 6.0817885057112141E+17 9.2015578714276935E-01 0.0000000000000000E+00 1.3740285715465250E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0265898422463071E-12 4.9668313900960837E-01 0.0000000000000000E+00 4.9782192167987688E-01 5.4723507760924186E-03 2.2584522210866403E-05 4.0111738738092519E-09 1.3728522218725331E-15 2.9852599248881828E-23 1.3701907641633832E-32 1.2874642219610423E-43 1.5608723616908583E-56 1.2237615137677676E-70 0.0000000000000000E+00 5.3864257174359753E-88 --- ---
- 147: 2.1892583595293722E+33 9.7754445131328359E+07 2.7454515166555643E+02 1.6613567688361141E+08 1.4073884972376809E+08 4.2552364453629204E+25 5.9677165961782336E+17 9.2055565194721767E-01 0.0000000000000000E+00 1.3740260505483645E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0218051492015800E-12 4.9668634810493562E-01 0.0000000000000000E+00 4.9782403071085635E-01 5.4670564267740047E-03 2.2560751077809560E-05 4.0053235616010582E-09 1.3703237819017897E-15 2.9782776180076836E-23 1.3662097236240597E-32 1.2827655908528997E-43 1.5535680647042729E-56 1.2161556685380958E-70 0.0000000000000000E+00 5.3375745227171335E-88 --- ---
- 148: 2.2088767848964524E+33 9.8772150720973417E+07 2.7695677237867369E+02 1.5887134378585094E+08 1.3773921182615501E+08 4.0036096517662585E+25 5.8541236287450586E+17 9.2094310718870975E-01 0.0000000000000000E+00 1.3740238637683365E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0176760540670123E-12 4.9668913178408092E-01 0.0000000000000000E+00 4.9782586012587449E-01 5.4624639235895216E-03 2.2540165142440864E-05 4.0002841369925723E-09 1.3681521406522799E-15 2.9722951765226549E-23 1.3628050884543053E-32 1.2787545330175209E-43 1.5473465267009734E-56 1.2096989055837654E-70 0.0000000000000000E+00 5.2963016622523274E-88 --- ---
- 149: 2.2281902373173027E+33 9.9798965088967070E+07 2.7937191931916203E+02 1.5183856162158549E+08 1.3478586750291657E+08 3.7638231263700409E+25 5.7409578097409318E+17 9.2131801299914906E-01 0.0000000000000000E+00 1.3740221144414836E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0143891716242727E-12 4.9669135862048264E-01 0.0000000000000000E+00 4.9782732356773068E-01 5.4587900952559722E-03 2.2523719229929375E-05 3.9962757196002796E-09 1.3664289336718805E-15 2.9675576116175795E-23 1.3601130560901076E-32 1.2755877489797435E-43 1.5424435346431683E-56 1.2046244576294158E-70 0.0000000000000000E+00 5.2639921769576042E-88 --- ---
- 150: 2.2472043584656280E+33 1.0083567068811572E+08 2.8179148577775373E+02 1.4502913576283041E+08 1.3187713901954643E+08 3.5353445855855702E+25 5.6281660209537056E+17 9.2168030400713419E-01 0.0000000000000000E+00 1.3740209631692453E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0122346449991605E-12 4.9669282416082183E-01 0.0000000000000000E+00 4.9782828668824419E-01 5.4563722499469183E-03 2.2512906315445538E-05 3.9936486719183181E-09 1.3653015708875399E-15 2.9644627871800815E-23 1.3583564796720697E-32 1.2735236800341604E-43 1.5392521395390501E-56 1.2013280966428021E-70 0.0000000000000000E+00 5.2430646428137997E-88 --- ---
- 151: 2.2659246744334769E+33 1.0188310486752994E+08 2.8413129479272806E+02 1.3843463083861804E+08 1.2907750928409387E+08 3.3176690339105303E+25 5.5157157584910278E+17 9.2220838634087265E-01 0.0000000000000000E+00 1.3736623561440073E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.5023920473795876E-13 4.9714953994662692E-01 0.0000000000000000E+00 4.9812824209870910E-01 4.7028615139678345E-03 1.9353049435139344E-05 3.3904928528669609E-09 1.1453484359691774E-15 2.4483740445273258E-23 1.1019576553811556E-32 1.0093057138789650E-43 1.1831896342891684E-56 8.8777155858024996E-71 0.0000000000000000E+00 3.6361136350344907E-88 --- ---
- 152: 2.2843565982992821E+33 1.0294218695870821E+08 2.8647952691103245E+02 1.3204444512114492E+08 1.2693748150723650E+08 3.1103172584873126E+25 5.4036598459042477E+17 9.2375212678980445E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.3405798150787520E-27 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 3.6919577134166722E-26 1.5042087238797618E-62 3.3273132459915733E-56 4.6159689531548120E-57 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 153: 2.3025054326349690E+33 1.0401388446295899E+08 2.8883709312103531E+02 1.2585382489204998E+08 1.2623383648646533E+08 2.9128345770190058E+25 5.2917838720502387E+17 9.2475849548682476E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3871757430054733E-27 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.2039651114897597E-26 3.7798858144986151E-63 1.4870942907478176E-56 2.0722563048766315E-57 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 154: 2.3203763719536581E+33 1.0509922435494778E+08 2.9120494280196260E+02 1.1985753029592526E+08 1.2553021689327267E+08 2.7247893327372661E+25 5.1800490396735456E+17 9.2581116599609814E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6083541834724292E-27 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3091096120225460E-26 9.4303670767177238E-64 6.5959949171149863E-57 9.2350481245817936E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 155: 2.3379745050994525E+33 1.0619931543563490E+08 2.9358403948613835E+02 1.1404891747310027E+08 1.2482624023572771E+08 2.5457715405704309E+25 5.0683915149370906E+17 9.2691422905312304E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5421060679340656E-27 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 7.7337858676073030E-27 2.3317493989133802E-64 2.9016548472089089E-57 4.0830633447619111E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 156: 2.3553048175807600E+33 1.0731535927537337E+08 2.9597535911137061E+02 1.0842161017498697E+08 1.2412093377826118E+08 2.3753917283231164E+25 4.9567440813968806E+17 9.2807197524209650E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.0608354323666503E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 4.5412837450930230E-27 5.7005687556558784E-65 1.2647548636309320E-57 1.7892267583129634E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 157: 2.3723721938485611E+33 1.0844866294727774E+08 2.9837988687494482E+02 1.0296948521095800E+08 1.2341301654530196E+08 2.2132798560636592E+25 4.8450356470154630E+17 9.2928900996766184E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.2869345130701058E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.6484933688637190E-27 1.3742864114348120E-65 5.4554951163174906E-58 7.7617378150860778E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 158: 2.3891814195209998E+33 1.0960065394148889E+08 3.0079861263808584E+02 9.7686657471031159E+07 1.2270168271319094E+08 2.0590843089289493E+25 4.7331907046187411E+17 9.3057063896968706E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0615507981440096E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.5330747153953630E-27 3.2594920075074676E-66 2.3263777880219240E-58 3.3298900012068896E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 159: 2.4057371835556315E+33 1.1077289770383288E+08 3.0323252374469928E+02 9.2567468399291962E+07 1.2198625198291445E+08 1.9124709591932593E+25 4.6211286240178880E+17 9.3192285207859848E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7583154327657850E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 8.8019704174954500E-28 7.5883293978751911E-67 9.7970228034390239E-59 1.4113714596828737E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 160: 2.4220440803706373E+33 1.1196711839704950E+08 3.0568259501471931E+02 8.7606474452770039E+07 1.2126595372376037E+08 1.7731222938146640E+25 4.5087628350340186E+17 9.3335234263906985E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0008025162454409E-28 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 5.0086493866592527E-28 1.7298471162101917E-67 4.0697662663510132E-59 5.9033988157931132E-60 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 161: 2.4381066119162685E+33 1.1318522364893793E+08 3.0814977428807720E+02 8.2798435414466128E+07 1.2053989732701932E+08 1.6407366042717299E+25 4.3959998782599405E+17 9.3486661453151376E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.6406512489507791E-29 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.8223648467982957E-28 3.8511117457145199E-68 1.6654473089009702E-59 2.4336253879357443E-60 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 162: 2.4539291896977627E+33 1.1442933426525903E+08 3.1063496223904394E+02 7.8138302928894877E+07 1.1980704391624354E+08 1.5150272361162390E+25 4.2827382775907059E+17 9.3647411371725187E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.1449801307240609E-29 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 1.5733728914947435E-28 8.3486811696497686E-69 6.7037779383049222E-60 9.8731589359866086E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 163: 2.4695161367509312E+33 1.1570182017838824E+08 3.1313898432505482E+02 7.3621209150906608E+07 1.1906617172953086E+08 1.3957218962901996E+25 4.1688671899881069E+17 9.3818438753756095E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7327156365035413E-29 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 8.6673343415002486E-29 1.7566818861408822E-69 2.6495714118621738E-60 3.9352313916612346E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 164: 2.4848716895715934E+33 1.1700534430197871E+08 3.1566255110324983E+02 6.9242455358828917E+07 1.1831583253357700E+08 1.2825620169470951E+25 4.0542647749629568E+17 9.4000827882830973E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.4208616958924629E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 4.7119985041363988E-29 3.5745087552649281E-70 1.0261604142580744E-60 1.5379277445094246E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 165: 2.4999999999999987E+33 1.1834291651247758E+08 3.1820620342236987E+02 6.4997500347381368E+07 1.1755429494148700E+08 1.1753021753115362E+25 3.9387962079916826E+17 9.4195816370920571E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0471146042486868E-30 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 2.5241976800220841E-29 7.0041671141195757E-71 3.8851005619696958E-61 5.8795369543993170E-62 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 166: 2.5149051370613488E+33 1.1971796074848393E+08 3.2077023484897694E+02 6.0881948360403396E+07 1.1677947074624032E+08 1.0737095700640410E+25 3.8223112369502502E+17 9.4404824577327695E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6594912033516614E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3300009707243229E-29 1.3151730237219599E-71 1.4338719892590437E-61 2.1927800292671012E-62 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 167: 2.5299552941601440E+33 1.2117036199772725E+08 3.2341941245157290E+02 5.6841795613692038E+07 1.1597855989321880E+08 9.7638019636905630E+24 3.7031428463037453E+17 9.4632436049989366E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3636768848533609E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 6.8193634152998897E-30 2.3009756709736862E-72 5.0735076075454928E-62 7.8479773662274393E-63 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 168: 2.5455295344943751E+33 1.2274908739853859E+08 3.2622600487654444E+02 5.2777823525357701E+07 1.1512612326779735E+08 8.8099504963425956E+24 3.5779027648314106E+17 9.4887892861629319E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.6584675321054611E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 3.3295835153181405E-30 3.5445049492148971E-73 1.6640386787091873E-62 2.6073334584439323E-63 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 169: 2.5620467932126522E+33 1.2451875827058464E+08 3.2927554247139182E+02 4.8590670398293354E+07 1.1418974266572841E+08 7.8549996212260656E+24 3.4425318000450195E+17 9.5184337594157609E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0101490480772979E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.5051863589284615E-30 4.4675153236701197E-74 4.8429033066758774E-63 7.7023265214666799E-64 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 170: 2.5799999999999987E+33 1.2657068294562793E+08 3.3267363184678408E+02 4.4173740780482635E+07 1.1312431350572111E+08 6.8800525126823539E+24 3.2917885347167494E+17 9.5541583611133762E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2112287437422864E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 6.0564461589138110E-31 4.1568553514866218E-75 1.1762450783298725E-63 1.9046403865689518E-64 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 171: 2.5999999999999986E+33 1.2904320701641238E+08 3.3655255631253937E+02 3.9405527992334977E+07 1.1186110692472219E+08 5.8674904231304531E+24 3.1184081110655674E+17 9.5991476781406215E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0848971774359040E-32 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.0425120441583794E-31 2.4410990937878109E-76 2.1712191937595975E-64 3.5957382265752900E-65 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 172: 2.6199999999999985E+33 1.3175625787056336E+08 3.4050542365524160E+02 3.4497937471288711E+07 1.1039888865778555E+08 4.8721337721886062E+24 2.9261867679981952E+17 9.6544703182352687E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1531516829813869E-32 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 5.7658615432242697E-32 9.0186367869252008E-78 3.0387415074486714E-65 5.1720162517853435E-66 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 173: 2.6399999999999984E+33 1.3477355147228181E+08 3.4447503354316734E+02 2.9699724558469199E+07 1.0874301479878481E+08 3.9492176113409234E+24 2.7216899889763110E+17 9.7203716821945452E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7496864558658734E-33 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3748563927003019E-32 2.1475789897614492E-79 3.2674403582529772E-66 5.7418272833217933E-67 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 174: 2.6599999999999983E+33 1.3819019024756944E+08 3.4833335823611651E+02 2.5006243296655238E+07 1.0679746679766408E+08 3.0997805579758208E+24 2.5016785123881373E+17 9.8004219215009203E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.1422695058868307E-34 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.5711466401764996E-33 2.7196353625084538E-81 2.4010061212605805E-67 4.3807704550441379E-68 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 175: 2.6799999999999983E+33 1.4215864895523050E+08 3.5178074221960287E+02 2.0409469968600746E+07 1.0438569215875655E+08 2.3254636482871482E+24 2.2612195032166470E+17 9.9001450880544573E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.5883923786990250E-35 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 3.2942024670224420E-34 1.2909023042392929E-83 9.7333611228616212E-69 1.8564558887584838E-69 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 176: 2.6999999999999982E+33 1.4695018090140510E+08 3.5403422574901850E+02 1.5894367890850307E+07 1.0114415236188327E+08 1.6288570070343807E+24 1.9921166467033670E+17 1.0028696583432049E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3697770257503894E-36 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.1848898225237199E-35 1.1136937091660816E-86 1.3946184804045528E-70 2.8023721144191963E-71 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 177: 2.7199999999999981E+33 1.5313496771292946E+08 3.5256410331119758E+02 1.1428912177552676E+07 9.6185550277910799E+07 1.0142051040904335E+24 1.6787689373191885E+17 1.0202749978574841E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 178: 2.7399999999999980E+33 1.6236563909388980E+08 3.3449941217953739E+02 6.9266387214061683E+06 8.6411092209708214E+07 4.8913488477541260E+23 1.2830835334566934E+17 1.0453470734688393E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
diff --git a/Util/initial_models/kepler_hybrid/kepler_new_6.e8.dat b/Util/initial_models/kepler_hybrid/kepler_new_6.e8.dat
deleted file mode 100644
index 61e134d83..000000000
--- a/Util/initial_models/kepler_hybrid/kepler_new_6.e8.dat
+++ /dev/null
@@ -1,180 +0,0 @@
-# VERSION 10104 -- Thu Aug 27 17:55:11 2009 UTC -- created by woosley on banzai.ucolick.org from file /data/woosley/banzai/u/woosley/cdef/fudgc#t8eq6
- grid cell outer total mass cell outer radius cell outer velocity cell density cell temperature cell pressure cell specific energy cell specific entropy cell angular velocity cell A_bar cell Y_e stability NETWORK neutrons H1 He3 He4 C12 N14 O16 Ne20 Mg24 Si28 S32 Ar36 Ca40 Ti44 Cr48 Fe52 Fe54 Ni56 Fe56 'Fe'
- 1: 9.9999999999607598E+28 2.0746178464367485E+06 9.3366450464756201E-01 2.6736038762760334E+09 5.9989428978759503E+08 1.8018799006692461E+27 1.8022261574801024E+18 8.6835234037290476E-01 0.0000000000000000E+00 1.3734432898100277E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7369798170247852E-12 4.9742773687497299E-01 0.0000000000000000E+00 4.9831271047957315E-01 4.2440736930931472E-03 1.5477268705407193E-05 1.6809115056549564E-09 3.5760298098904115E-16 4.1918602197357876E-24 9.3037023253840634E-34 3.2887284826837408E-45 1.0667945384139518E-58 1.9261289189701197E-73 0.0000000000000000E+00 1.7752813949401407E-91 --- ---
- 2: 2.4523015847725093E+29 2.7984720328276730E+06 1.2594014872308776E+00 2.6697127518126245E+09 5.9936764804302073E+08 1.7983666639352590E+27 1.8012448104131174E+18 8.6837833473932025E-01 0.0000000000000000E+00 1.3734432573326925E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7358654328274360E-12 4.9742777822210754E-01 0.0000000000000000E+00 4.9831273775084889E-01 4.2440053838818997E-03 1.5476959600817585E-05 1.6808182066456493E-09 3.5757550160934321E-16 4.1913779970203622E-24 9.3022124789062386E-34 3.2879671405283174E-45 1.0664289886929234E-58 1.9252587495937746E-73 0.0000000000000000E+00 1.7743018776484322E-91 --- ---
- 3: 4.4308952902951118E+29 3.4095447048010444E+06 1.5343669602768921E+00 2.6656784477396007E+09 5.9882116589100385E+08 1.7947259761844301E+27 1.8002263537972854E+18 8.6840532176631002E-01 0.0000000000000000E+00 1.3734432165679085E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7344559594959718E-12 4.9742783012014574E-01 0.0000000000000000E+00 4.9831277198060531E-01 4.2439196445962484E-03 1.5476571210115793E-05 1.6807014672132963E-09 3.5754112656425653E-16 4.1907756953937968E-24 9.3003547685930734E-34 3.2870203674131837E-45 1.0659761281684966E-58 1.9241845402617962E-73 0.0000000000000000E+00 1.7730963245311712E-91 --- ---
- 4: 6.9611778106595762E+29 3.9649785064251618E+06 1.7842776786224015E+00 2.6613285810301337E+09 5.9823146043371534E+08 1.7908025975902963E+27 1.7991270921092227E+18 8.6843446689399684E-01 0.0000000000000000E+00 1.3734431668879294E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7327239247442965E-12 4.9742789336832538E-01 0.0000000000000000E+00 4.9831281369568653E-01 4.2438151553528597E-03 1.5476097336068847E-05 1.6805596804990714E-09 3.5749938648520924E-16 4.1900455646976888E-24 9.2981068531045643E-34 3.2858780383402731E-45 1.0654319427676104E-58 1.9228985151675702E-73 0.0000000000000000E+00 1.7716576092361120E-91 --- ---
- 5: 9.9999999999953474E+29 4.4754306342457570E+06 2.0139310806561244E+00 2.6567105854497766E+09 5.9760489208335698E+08 1.7866397478487367E+27 1.7979587712804721E+18 8.6846546578697448E-01 0.0000000000000000E+00 1.3734431091398950E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7306925359740616E-12 4.9742796688819546E-01 0.0000000000000000E+00 4.9831286218447968E-01 4.2436936983677219E-03 1.5475545824279759E-05 1.6803954688879731E-09 3.5745105700729496E-16 4.1892016745834636E-24 9.2955136852905060E-34 3.2845643074378017E-45 1.0648087874661163E-58 1.9214316056762701E-73 0.0000000000000000E+00 1.7700218789615420E-91 --- ---
- 6: 1.3428633252745263E+30 4.9393399572783234E+06 2.2226276017648727E+00 2.6519615938327718E+09 5.9696001862323749E+08 1.7823613605292763E+27 1.7967559119076562E+18 8.6849740806909204E-01 0.0000000000000000E+00 1.3734430454279249E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7284303152779650E-12 4.9742804800101637E-01 0.0000000000000000E+00 4.9831291567998826E-01 4.2435596994763788E-03 1.5474936568865892E-05 1.6802149873236208E-09 3.5739795210845019E-16 4.1882761118787520E-24 9.2926751812675008E-34 3.2831308363307323E-45 1.0641318254970399E-58 1.9198443213331175E-73 0.0000000000000000E+00 1.7682576816718245E-91 --- ---
- 7: 1.7264416518296091E+30 5.3728243141862769E+06 2.4176206368777455E+00 2.6471306825429945E+09 5.9630348242623496E+08 1.7780118253080451E+27 1.7955308409663987E+18 8.6852997002087529E-01 0.0000000000000000E+00 1.3734429769332548E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7259752872292892E-12 4.9742813520296858E-01 0.0000000000000000E+00 4.9831297319021928E-01 4.2434156433320547E-03 1.5474280725574295E-05 1.6800216979199057E-09 3.5734109155348244E-16 4.1872869187182717E-24 9.2896474997903790E-34 3.2816066263156968E-45 1.0634151373852227E-58 1.9181703423623707E-73 0.0000000000000000E+00 1.7664029419107221E-91 --- ---
- 8: 2.1519480749731376E+30 5.7844297728337757E+06 2.6027560158475578E+00 2.6421866836956291E+09 5.9563102450242579E+08 1.7735632460206578E+27 1.7942755628855516E+18 8.6856336746180329E-01 0.0000000000000000E+00 1.3734429035780707E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7233207753080066E-12 4.9742822859315067E-01 0.0000000000000000E+00 4.9831303478033789E-01 4.2432613665537846E-03 1.5473577412001488E-05 1.6798154927333990E-09 3.5728044428649304E-16 4.1862338090431191E-24 9.2864305333910245E-34 3.2799922121370137E-45 1.0626593195859706E-58 1.9164116239045588E-73 0.0000000000000000E+00 1.7644602102274736E-91 --- ---
- 9: 2.6199836119821814E+30 6.1790053563027531E+06 2.7802158561144950E+00 2.6371176465078287E+09 5.9494098652599871E+08 1.7690050761884472E+27 1.7929869266395067E+18 8.6859768779766333E-01 0.0000000000000000E+00 1.3734428254302570E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7204650929540913E-12 4.9742832808517157E-01 0.0000000000000000E+00 4.9831310039316806E-01 4.2430970122025215E-03 1.5472827133931226E-05 1.6795966788270523E-09 3.5721610108195781E-16 4.1851186206472922E-24 9.2830306757256068E-34 3.2782913965793540E-45 1.0618664952407711E-58 1.9145736430795833E-73 0.0000000000000000E+00 1.7624358873056314E-91 --- ---
- 10: 3.1304576633028770E+30 6.5593644007670209E+06 2.9512662832430596E+00 2.6319237203287687E+09 5.9423335198593211E+08 1.7643376726842803E+27 1.7916648442643374E+18 8.6863293706119515E-01 0.0000000000000000E+00 1.3734427426830777E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7174110614838810E-12 4.9742843343301507E-01 0.0000000000000000E+00 4.9831316986626306E-01 4.2429229870316835E-03 1.5472031599999273E-05 1.6793659128922134E-09 3.5714825517562515E-16 4.1839449584587625E-24 9.2794596657615716E-34 3.2765106175869993E-45 1.0610399840731449E-58 1.9126645644482436E-73 0.0000000000000000E+00 1.7603392460963752E-91 --- ---
- 11: 3.6825249259031809E+30 6.9271051549679721E+06 3.1166267624576585E+00 2.6266135827842073E+09 5.9350926609509230E+08 1.7595690539532568E+27 1.7903113993235707E+18 8.6866906332650251E-01 0.0000000000000000E+00 1.3734426556430590E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7141658062080858E-12 4.9742854424646699E-01 0.0000000000000000E+00 4.9831324294209151E-01 4.2427399359823668E-03 1.5471193614083751E-05 1.6791241599137063E-09 3.5707719002211980E-16 4.1827179647019151E-24 9.2757338316231391E-34 3.2746585264981450E-45 1.0601840790836525E-58 1.9106946743788217E-73 0.0000000000000000E+00 1.7581817721247607E-91 --- ---
- 12: 4.2745430717472685E+30 7.2830604762273822E+06 3.2766724989645408E+00 2.6212023579225945E+09 5.9277075679210603E+08 1.7547130056887676E+27 1.7889303300244362E+18 8.6870597020443829E-01 0.0000000000000000E+00 1.3734425647198877E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7107406178835743E-12 4.9742866000397468E-01 0.0000000000000000E+00 4.9831331927652922E-01 4.2425487209194843E-03 1.5470316986549259E-05 1.6788726581483929E-09 3.5700326895680830E-16 4.1814441243252509E-24 9.2718734509671268E-34 3.2727456324954073E-45 1.0593038601249489E-58 1.9086759162097868E-73 0.0000000000000000E+00 1.7559766301893922E-91 --- ---
- 13: 4.9040548040414248E+30 7.6275653052127995E+06 3.4315548229373807E+00 2.6157102150597630E+09 5.9202054741683161E+08 1.7497878030778206E+27 1.7875266829727027E+18 8.6874352583105519E-01 0.0000000000000000E+00 1.3734424704155897E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7071507769449846E-12 4.9742878006641755E-01 0.0000000000000000E+00 4.9831339844795131E-01 4.2423503978661972E-03 1.5469406438031174E-05 1.6786128828466164E-09 3.5692692453330725E-16 4.1801310671696018E-24 9.2679021104948763E-34 3.2707839544080660E-45 1.0584050165782415E-58 1.9066214600251018E-73 0.0000000000000000E+00 1.7537381819076055E-91 --- ---
- 14: 5.5677969247037119E+30 7.9606269124215981E+06 3.5812778097350586E+00 2.6101612919729033E+09 5.9126191280662048E+08 1.7448152282002658E+27 1.7861065475080438E+18 8.6878156974231902E-01 0.0000000000000000E+00 1.3734423733122048E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7034153024801463E-12 4.9742890369280246E-01 0.0000000000000000E+00 4.9831347996759218E-01 4.2421461910606929E-03 1.5468467487795946E-05 1.6783465067235482E-09 3.5684864694777806E-16 4.1787873571332028E-24 9.2638460360107666E-34 3.2687866662517756E-45 1.0574936729448629E-58 1.9045452918589868E-73 0.0000000000000000E+00 1.7514815356538756E-91 --- ---
- 15: 6.2617378337997012E+30 8.2820396713618133E+06 3.7257499266913219E+00 2.6045827746650753E+09 5.9049855603674448E+08 1.7398197315892475E+27 1.7846768280244065E+18 8.6881991877446152E-01 0.0000000000000000E+00 1.3734422740576935E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6995566056746168E-12 4.9742903005820249E-01 0.0000000000000000E+00 4.9831356329138388E-01 4.2419374633078221E-03 1.5467506323891691E-05 1.6780753567483307E-09 3.5676897141750077E-16 4.1774222665331317E-24 9.2597333886511409E-34 3.2667677349776075E-45 1.0565762167544900E-58 1.9024618199730121E-73 0.0000000000000000E+00 1.7492221245714231E-91 --- ---
- 16: 6.9811435023736388E+30 8.5914663015774004E+06 3.8648205819705357E+00 2.5990040532398314E+09 5.8973449484275210E+08 1.7348276657946473E+27 1.7832450336993871E+18 8.6885837254381482E-01 0.0000000000000000E+00 1.3734421733501955E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6956000407628414E-12 4.9742915827379841E-01 0.0000000000000000E+00 4.9831364783317755E-01 4.2417256828641350E-03 1.5466529655817981E-05 1.6778013678029132E-09 3.5668846466752315E-16 4.1760455387036307E-24 9.2555935371974610E-34 3.2647415556684877E-45 1.0556591310952308E-58 1.9003855021395891E-73 0.0000000000000000E+00 1.7469753150611043E-91 --- ---
- 17: 7.7206704983561684E+30 8.8884977413017079E+06 3.9983070481774505E+00 2.5934559174743705E+09 5.8897395273397779E+08 1.7298665584559833E+27 1.7818190762204838E+18 8.6889671876320718E-01 0.0000000000000000E+00 1.3734420719211899E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6915733650197242E-12 4.9742928740831227E-01 0.0000000000000000E+00 4.9831373297888187E-01 4.2415123880258981E-03 1.5465544554793665E-05 1.6775265349042078E-09 3.5660771101226489E-16 4.1746671473933899E-24 9.2514563323956842E-34 3.2627225967879279E-45 1.0547488371237497E-58 1.8983305043679796E-73 0.0000000000000000E+00 1.7447560550538799E-91 --- ---
- 18: 8.4744831964120764E+30 9.1726986756650209E+06 4.1260149234366486E+00 2.5879697794170837E+09 5.8822125305501127E+08 1.7249644136500401E+27 1.7804070721761731E+18 8.6893473848846703E-01 0.0000000000000000E+00 1.3734419705179802E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6875061164124499E-12 4.9742941651031397E-01 0.0000000000000000E+00 4.9831381810117303E-01 4.2412991502802384E-03 1.5464558285388906E-05 1.6772528651805285E-09 3.5652729836993820E-16 4.1732970587285670E-24 9.2473514000393466E-34 3.2607250630263066E-45 1.0538515493070972E-58 1.8963103952363796E-73 0.0000000000000000E+00 1.7425785645220196E-91 --- ---
- 19: 9.2363909657969134E+30 9.4436429149831720E+06 4.2477540185925609E+00 2.5825769236517391E+09 5.8748071608797157E+08 1.7201490420862952E+27 1.7790171502563674E+18 8.6897221129333369E-01 0.0000000000000000E+00 1.3734418698861772E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6834289323024847E-12 4.9742954463051625E-01 0.0000000000000000E+00 4.9831390257419522E-01 4.2410875374805290E-03 1.5463578135191129E-05 1.6769823314637138E-09 3.5644780474472319E-16 4.1719450046419673E-24 9.2433074783305854E-34 3.2587625870935390E-45 1.0529731476345623E-58 1.8943378832076397E-73 0.0000000000000000E+00 1.7404560742809843E-91 --- ---
- 20: 9.9999999999996709E+30 9.7009411920316070E+06 4.3633508280241484E+00 2.5773077933419719E+09 5.8675656034264529E+08 1.7154474272356604E+27 1.7776572654217823E+18 8.6900892031432664E-01 0.0000000000000000E+00 1.3734417707527223E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6793728298522804E-12 4.9742967084339496E-01 0.0000000000000000E+00 4.9831398578781283E-01 4.2408790781412560E-03 1.5462611247631109E-05 1.6767168287781069E-09 3.5636978554258100E-16 4.1706202735613572E-24 9.2393518151360966E-34 3.2568479565833678E-45 1.0521190685176950E-58 1.8924245986251406E-73 0.0000000000000000E+00 1.7384006132237291E-91 --- ---
- 21: 1.0758873610036410E+31 9.9442629846476503E+06 4.4726583087344860E+00 2.5721913240623083E+09 5.8605280974677002E+08 1.7108851377634740E+27 1.7763350233136292E+18 8.6904465707338452E-01 0.0000000000000000E+00 1.3734416738100760E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6753684778036060E-12 4.9742979426731537E-01 0.0000000000000000E+00 4.9831406716087534E-01 4.2406752282041901E-03 1.5461664464418966E-05 1.6764581352445771E-09 3.5629376215877632E-16 4.1693315252102932E-24 9.2355096435563968E-34 3.2549928831618430E-45 1.0512942165399580E-58 1.8905809232679682E-73 0.0000000000000000E+00 1.7364228457244598E-91 --- ---
- 22: 1.1525759183621215E+31 1.0179065649752676E+07 4.5781292022257389E+00 2.5671918485209055E+09 5.8536460320140898E+08 1.7064301309944124E+27 1.7750413381384276E+18 8.6907966407392767E-01 0.0000000000000000E+00 1.3734415785088496E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6713957460538332E-12 4.9742991560171951E-01 0.0000000000000000E+00 4.9831414715465322E-01 4.2404748322299145E-03 1.5460732514102656E-05 1.6762047053398834E-09 3.5621927956968360E-16 4.1680708494776092E-24 9.2317567582229056E-34 3.2531851840476338E-45 1.0504928641124423E-58 1.8887934870537138E-73 0.0000000000000000E+00 1.7345079822682588E-91 --- ---
- 23: 1.2313811497487103E+31 1.0410004824601252E+07 4.6818552982329535E+00 2.5622167916052976E+09 5.8467922005311418E+08 1.7019997925961259E+27 1.7737523202317724E+18 8.6911458632694150E-01 0.0000000000000000E+00 1.3734414831709541E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6673856772603550E-12 4.9743003698308474E-01 0.0000000000000000E+00 4.9831422717774781E-01 4.2402743615129425E-03 1.5459799027939925E-05 1.6759520373392248E-09 3.5614501381497708E-16 4.1668157324091116E-24 9.2280257862514059E-34 3.2513921211412094E-45 1.0497003125053337E-58 1.8870291439824530E-73 0.0000000000000000E+00 1.7326202228908010E-91 --- ---
- 24: 1.3137275361782613E+31 1.0641295667538006E+07 4.7857298294462236E+00 2.5571776409083686E+09 5.8398445965532601E+08 1.6975153401617955E+27 1.7724450111286003E+18 8.6915004665145668E-01 0.0000000000000000E+00 1.3734413861521260E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6632682093509307E-12 4.9743016050484462E-01 0.0000000000000000E+00 4.9831430861026638E-01 4.2400703586376650E-03 1.5458847885165680E-05 1.6756957802158628E-09 3.5606968479451149E-16 4.1655445371189763E-24 9.2242523522216609E-34 3.2495826958303942E-45 1.0489028040468624E-58 1.8852571110906129E-73 0.0000000000000000E+00 1.7307264863844872E-91 --- ---
- 25: 1.4012262626283836E+31 1.0876985718353521E+07 4.8915700616803193E+00 2.5519847666290650E+09 5.8326792809651005E+08 1.6928972087017346E+27 1.7710960417307026E+18 8.6918668205486060E-01 0.0000000000000000E+00 1.3734412857538626E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6589684094044557E-12 4.9743028832950642E-01 0.0000000000000000E+00 4.9831439287773743E-01 4.2398592523084496E-03 1.5457862350198019E-05 1.6754314991100053E-09 3.5599198713888396E-16 4.1642353298842116E-24 9.2203715639604923E-34 3.2477259383288697E-45 1.0480867497693578E-58 1.8834472116640546E-73 0.0000000000000000E+00 1.7287944978798433E-91 --- ---
- 26: 1.4957694626029211E+31 1.1121181775056245E+07 5.0012191406277724E+00 2.5465425135112362E+09 5.8251635727081728E+08 1.6880607060272135E+27 1.7696803451723971E+18 8.6922517903019281E-01 0.0000000000000000E+00 1.3734411801355906E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6544023945148109E-12 4.9743042280048033E-01 0.0000000000000000E+00 4.9831448152482066E-01 4.2396371726813259E-03 1.5456824201741977E-05 1.6751544487512477E-09 3.5591052334092267E-16 4.1628647604515862E-24 9.2163147045860764E-34 3.2457893304801141E-45 1.0472380356041460E-58 1.8815683233340921E-73 0.0000000000000000E+00 1.7267911171247108E-91 --- ---
- 27: 1.5996501841471306E+31 1.1378257967631178E+07 5.1166394012900902E+00 2.5407440609100814E+09 5.8171488630095458E+08 1.6829114924238901E+27 1.7681697918759027E+18 8.6926631141818533E-01 0.0000000000000000E+00 1.3734410672193851E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6494725635409970E-12 4.9743056656339546E-01 0.0000000000000000E+00 4.9831457629525550E-01 4.2393997510558170E-03 1.5455712777288398E-05 1.6748593350515519E-09 3.5582373327907144E-16 4.1614068978784632E-24 9.2120058368801269E-34 3.2437372196348011E-45 1.0463413426969185E-58 1.8795868826339066E-73 0.0000000000000000E+00 1.7246807438204051E-91 --- ---
- 28: 1.7157205765521055E+31 1.1653064356302513E+07 5.2400058021982945E+00 2.5344655875000997E+09 5.8084623979189777E+08 1.6773404808983328E+27 1.7665316213444429E+18 8.6931098437872301E-01 0.0000000000000000E+00 1.3734409445797320E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6440617032528018E-12 4.9743072270645389E-01 0.0000000000000000E+00 4.9831467922433881E-01 4.2391418881600725E-03 1.5454503856191153E-05 1.6745400468893502E-09 3.5572981476836174E-16 4.1598319345096295E-24 9.2073580669229219E-34 3.2415291063238636E-45 1.0453794315150058E-58 1.8774653333193666E-73 0.0000000000000000E+00 1.7224236777041175E-91 --- ---
- 29: 1.8476059264908175E+31 1.1951151400532926E+07 5.3738063383427432E+00 2.5275592487046218E+09 5.7988973206378317E+08 1.6712177365694969E+27 1.7647265333977718E+18 8.6936028845736313E-01 0.0000000000000000E+00 1.3734408093101743E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6380254132795450E-12 4.9743089493023379E-01 0.0000000000000000E+00 4.9831479275078888E-01 4.2388574738477141E-03 1.5453168295296348E-05 1.6741893398941279E-09 3.5562662966746588E-16 4.1581046719085253E-24 9.2022692249807875E-34 3.2391176991066906E-45 1.0443323468094371E-58 1.8751604253450267E-73 0.0000000000000000E+00 1.7199743339861892E-91 --- ---
- 30: 1.9999999999999630E+31 1.2279023806773752E+07 5.5209554352328647E+00 2.5198443891820040E+09 5.7882001259594750E+08 1.6643848886588900E+27 1.7627062726593080E+18 8.6941556869363212E-01 0.0000000000000000E+00 1.3734406578575081E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6311821129551110E-12 4.9743108775880324E-01 0.0000000000000000E+00 4.9831491985580040E-01 4.2385390386434386E-03 1.5451670316300450E-05 1.6737984531283947E-09 3.5551158972657070E-16 4.1561827005544441E-24 9.1966167243467892E-34 3.2364466372902332E-45 1.0431765064858671E-58 1.8726212871614976E-73 0.0000000000000000E+00 1.7172792328597630E-91 --- ---
- 31: 2.1790790876294910E+31 1.2644436675190374E+07 5.6849260225549836E+00 2.5110962694893022E+09 5.7760544487578750E+08 1.6566454586979792E+27 1.7604104923850092E+18 8.6947851530141840E-01 0.0000000000000000E+00 1.3734404858126256E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6232996199485067E-12 4.9743130680604619E-01 0.0000000000000000E+00 4.9831506423843425E-01 4.2381773142097061E-03 1.5449965322850400E-05 1.6733566382448781E-09 3.5538151584862278E-16 4.1540141815193564E-24 9.1902513588895994E-34 3.2334477894255639E-45 1.0418836436221027E-58 1.8697872095317251E-73 0.0000000000000000E+00 1.7142746989558782E-91 --- ---
- 32: 2.3876492120280019E+31 1.3046562013875430E+07 5.8653370372279436E+00 2.5011707912127481E+09 5.7622537684587944E+08 1.6478754519101154E+27 1.7577993373285169E+18 8.6955027435871401E-01 0.0000000000000000E+00 1.3734402903994219E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6142050705956078E-12 4.9743155560681807E-01 0.0000000000000000E+00 4.9831522822674867E-01 4.2377664665003362E-03 1.5448024454090739E-05 1.6728576132771161E-09 3.5523453557469052E-16 4.1515695923155378E-24 9.1830907348527270E-34 3.2300854390615674E-45 1.0404399281236369E-58 1.8666296041323636E-73 0.0000000000000000E+00 1.7109313506226109E-91 --- ---
- 33: 2.6284136724418553E+31 1.3483794061025660E+07 6.0614574346346419E+00 2.4900326785157452E+09 5.7467411063276815E+08 1.6380479754737669E+27 1.7548610140375363E+18 8.6963123597789227E-01 0.0000000000000000E+00 1.3734400710659223E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6038176328822488E-12 4.9743183486428039E-01 0.0000000000000000E+00 4.9831541228195075E-01 4.2373053382250428E-03 1.5445840632095613E-05 1.6723009426571194E-09 3.5507049105345681E-16 4.1488482229720356E-24 9.1751374863992234E-34 3.2263642201926125E-45 1.0388490307550824E-58 1.8631582368029471E-73 0.0000000000000000E+00 1.7072604112285136E-91 --- ---
- 34: 2.9038797845213166E+31 1.3953839329112472E+07 6.2722469491253836E+00 2.4776664470058122E+09 5.7294857513532615E+08 1.6271542865563177E+27 1.7515885271085322E+18 8.6972166978806908E-01 0.0000000000000000E+00 1.3734398277616316E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5920719613800401E-12 4.9743214464315627E-01 0.0000000000000000E+00 4.9831561644417904E-01 4.2367938267999106E-03 1.5443411578225976E-05 1.6716875453305240E-09 3.5488961730929678E-16 4.1458559889383322E-24 9.1664137240517949E-34 3.2222979136785663E-45 1.0371184962785247E-58 1.8593911352894622E-73 0.0000000000000000E+00 1.7032816820275009E-91 --- ---
- 35: 3.2162587678984315E+31 1.4453829565181440E+07 6.4964071966785415E+00 2.4640775589430537E+09 5.7104850500770044E+08 1.6152047067326945E+27 1.7479800372105636E+18 8.6982171391363905E-01 0.0000000000000000E+00 1.3734395609711161E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5789219019401541E-12 4.9743248432695408E-01 0.0000000000000000E+00 4.9831584030441739E-01 4.2362329547967134E-03 1.5440740226222282E-05 1.6710197209049237E-09 3.5469255094878809E-16 4.1426054476050657E-24 9.1569607399003396E-34 3.2179090538307262E-45 1.0352594426973294E-58 1.8553537882662278E-73 0.0000000000000000E+00 1.6990226249758545E-91 --- ---
- 36: 3.5673624784155728E+31 1.4980442927628407E+07 6.7324364978365141E+00 2.4492929000992031E+09 5.6897653459488726E+08 1.6022288859288841E+27 1.7440390705301348E+18 8.6993136723560494E-01 0.0000000000000000E+00 1.3734392717209769E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5643438400567363E-12 4.9743285260906811E-01 0.0000000000000000E+00 4.9831608299877184E-01 4.2356248843936446E-03 1.5437834894125665E-05 1.6703010974232927E-09 3.5448031664414172E-16 4.1391154323559868E-24 9.1468375840297774E-34 3.2132280058990950E-45 1.0332860426323485E-58 1.8510779044411172E-73 0.0000000000000000E+00 1.6945170090075845E-91 --- ---
- 37: 3.9585013844433089E+31 1.5530021828727933E+07 6.9786832131854046E+00 2.4333606365376353E+09 5.6673821424784636E+08 1.5882754718324569E+27 1.7397745933021284E+18 8.7005048457809853E-01 0.0000000000000000E+00 1.3734389615597252E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5483395130762700E-12 4.9743324751837259E-01 0.0000000000000000E+00 4.9831634322550405E-01 4.2349728748290634E-03 1.5434709202466253E-05 1.6695365064917795E-09 3.5425429302861377E-16 4.1354103470954202E-24 9.1361186814993192E-34 3.2082916263794229E-45 1.0312148513114891E-58 1.8465998878899546E-73 0.0000000000000000E+00 1.6898032898170162E-91 --- ---
- 38: 4.3903886984728140E+31 1.6098680012940247E+07 7.2333942367216437E+00 2.4163495159916892E+09 5.6434195675505495E+08 1.5734112498668057E+27 1.7352009648613791E+18 8.7017877451678161E-01 0.0000000000000000E+00 1.3734386325123481E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5309381071130414E-12 4.9743366647703779E-01 0.0000000000000000E+00 4.9831661928331161E-01 4.2342811866350532E-03 1.5431381745793883E-05 1.6687317983466449E-09 3.5401616149941394E-16 4.1315191954879953E-24 9.1248907463124463E-34 3.2031416541490746E-45 1.0290640567635070E-58 1.8419591996458112E-73 0.0000000000000000E+00 1.6849229008302680E-91 --- ---
- 39: 4.8630558330374140E+31 1.6682395347221859E+07 7.4947570482448453E+00 2.3983476735296788E+09 5.6179892037532997E+08 1.5577198175766929E+27 1.7303377795073549E+18 8.7031579964503847E-01 0.0000000000000000E+00 1.3734382870136537E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.5121974870983694E-12 4.9743410638537133E-01 0.0000000000000000E+00 4.9831690912741178E-01 4.2335549412580754E-03 1.5427875545932718E-05 1.6678936150699735E-09 3.5376784293892095E-16 4.1274744419048496E-24 9.1132493037807417E-34 3.1978229963840068E-45 1.0268527281407661E-58 1.8371967657970462E-73 0.0000000000000000E+00 1.6799186170732579E-91 --- ---
- 40: 5.3757843040777123E+31 1.7277087811853491E+07 7.7609350805684283E+00 2.3794609933697925E+09 5.5912283338236856E+08 1.5412998530401843E+27 1.7252096037330342E+18 8.7046097928336241E-01 0.0000000000000000E+00 1.3734379278258002E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4922044275879726E-12 4.9743456372679340E-01 0.0000000000000000E+00 4.9831721043887089E-01 4.2327999474786621E-03 1.5424217328759305E-05 1.6670291420937199E-09 3.5351142784645616E-16 4.1233108044727705E-24 9.1012951269185286E-34 3.1923820581784758E-45 1.0246001247367355E-58 1.8323535553446815E-73 0.0000000000000000E+00 1.6748331115977622E-91 --- ---
- 41: 5.9270588244899706E+31 1.7878684098383415E+07 8.0300970193251047E+00 2.3598110737777309E+09 5.5632976392979729E+08 1.5242630345757757E+27 1.7198456126387123E+18 8.7061359474012812E-01 0.0000000000000000E+00 1.3734375579465016E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4710737675769919E-12 4.9743503468468953E-01 0.0000000000000000E+00 4.9831752070172319E-01 4.2320225082844807E-03 1.5420436678904918E-05 1.6661458583574317E-09 3.5324910543577153E-16 4.1190640757579999E-24 9.0891308617442555E-34 3.1868652381044785E-45 1.0223251109203514E-58 1.8274694094072586E-73 0.0000000000000000E+00 1.6697077800173328E-91 --- ---
- 42: 6.5145456094108000E+31 1.8483171159834266E+07 8.3004410760572220E+00 2.3395328423495402E+09 5.5343783882066011E+08 1.5067316704536878E+27 1.7142791284039583E+18 8.7077279729389034E-01 0.0000000000000000E+00 1.3734371805142814E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4489464580795678E-12 4.9743551526303820E-01 0.0000000000000000E+00 4.9831783728252854E-01 4.2312292215969660E-03 1.5416565128989852E-05 1.6652513022258779E-09 3.5298309637610317E-16 4.1147700461520242E-24 9.0768580428338659E-34 3.1813176679327642E-45 1.0200456996143024E-58 1.8225821544414737E-73 0.0000000000000000E+00 1.6645818591568884E-91 --- ---
- 43: 7.1350988737330512E+31 1.9086641271228321E+07 8.5702153718024014E+00 2.3187718744413238E+09 5.5046691541201460E+08 1.4888361021512648E+27 1.7085470603995953E+18 8.7093761906664857E-01 0.0000000000000000E+00 1.3734367987167344E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4259865484822794E-12 4.9743600140320621E-01 0.0000000000000000E+00 4.9831815750735120E-01 4.2304267874163351E-03 1.5412635240440027E-05 1.6643528663211884E-09 3.5271559284441987E-16 4.1104635832686764E-24 9.0645746278161444E-34 3.1757822349866696E-45 1.0177787285538601E-58 1.8177269953918155E-73 0.0000000000000000E+00 1.6594918301962325E-91 --- ---
- 44: 7.7847971902777501E+31 1.9685330914385058E+07 8.8377354602450797E+00 2.2976814763275118E+09 5.4743821225569248E+08 1.4707119512483160E+27 1.7026892827707397E+18 8.7110698690295052E-01 0.0000000000000000E+00 1.3734364157052129E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.4023771394120838E-12 4.9743648909257715E-01 0.0000000000000000E+00 4.9831847873330443E-01 4.2296218285402080E-03 1.5408679711318438E-05 1.6634576258164558E-09 3.5244870719558526E-16 4.1061778787970014E-24 9.0523730550257901E-34 3.1702988668476558E-45 1.0155396496714727E-58 1.8129361378114043E-73 0.0000000000000000E+00 1.6544710505970535E-91 --- ---
- 45: 8.4590098686623695E+31 2.0275655320217699E+07 9.1013998067790070E+00 2.2764196045807619E+09 5.4437390554996848E+08 1.4524972863023413E+27 1.6967478707292196E+18 8.7127973922633406E-01 0.0000000000000000E+00 1.3734360345258429E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3783158826990437E-12 4.9743697445240087E-01 0.0000000000000000E+00 4.9831879840635795E-01 4.2288207456655921E-03 1.5404730618118360E-05 1.6625722182143968E-09 3.5218443476820439E-16 4.1019439400279092E-24 9.0403390159446605E-34 3.1649041435751157E-45 1.0133424487068272E-58 1.8082386711883983E-73 0.0000000000000000E+00 1.6495496487691291E-91 --- ---
- 46: 9.1524919059324317E+31 2.0854239938943502E+07 9.3597037896541373E+00 2.2551457020049515E+09 5.4129670086848199E+08 1.4343297901943373E+27 1.6907663567322296E+18 8.7145464578815679E-01 0.0000000000000000E+00 1.3734356580555346E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3540094573844232E-12 4.9743745381928195E-01 0.0000000000000000E+00 4.9831911411491753E-01 4.2280295830542615E-03 1.5400818682702897E-05 1.6617027421833734E-09 3.5192462145551445E-16 4.0977901641087065E-24 9.0285504569312972E-34 3.1596310020593030E-45 1.0111995921151556E-58 1.8036604926326554E-73 0.0000000000000000E+00 1.6447544517738017E-91 --- ---
- 47: 9.8595044599930061E+31 2.1417949559336405E+07 9.6112525473729171E+00 2.2340175365798750E+09 5.3822939046812737E+08 1.4163440092543378E+27 1.6847888775983260E+18 8.7163042994339879E-01 0.0000000000000000E+00 1.3734352889564063E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3296680750974169E-12 4.9743792380323482E-01 0.0000000000000000E+00 4.9831942362794179E-01 4.2272539329197920E-03 1.5396972712328978E-05 1.6608547012721223E-09 3.5167094410021429E-16 4.0937421149791624E-24 9.0170771345762426E-34 3.1545086670154440E-45 1.0091220526211776E-58 1.7992243829128196E-73 0.0000000000000000E+00 1.6401090659472511E-91 --- ---
- 48: 1.0573956320148394E+32 2.1963915314773522E+07 9.8547727846514057E+00 2.2131881321851206E+09 5.3519440830465871E+08 1.3986687623949916E+27 1.6788593206999135E+18 8.7180579300438688E-01 0.0000000000000000E+00 1.3734349296413766E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.3054998947319110E-12 4.9743838133151330E-01 0.0000000000000000E+00 4.9831972492367693E-01 4.2264988633162184E-03 1.5393219148188542E-05 1.6600329708463126E-09 3.5142489763302237E-16 4.0898223981260992E-24 9.0059804154085082E-34 3.1495626635033279E-45 1.0071193530493689E-58 1.7949501090011953E-73 0.0000000000000000E+00 1.6356339810562758E-91 --- ---
- 49: 1.1289560604909510E+32 2.2489559421034127E+07 1.0089123477213834E+01 2.1928028779307008E+09 5.3221339536965638E+08 1.3814247815185591E+27 1.6730204658061233E+18 8.7197944002747607E-01 0.0000000000000000E+00 1.3734345822510408E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.2817057033754320E-12 4.9743882367808179E-01 0.0000000000000000E+00 4.9832001620893401E-01 4.2257688697215140E-03 1.5389581732333730E-05 1.6592417851866344E-09 3.5118778835980139E-16 4.0860506194080553E-24 8.9953132769542714E-34 3.1448148905639149E-45 1.0051996210858416E-58 1.7908545411377959E-73 0.0000000000000000E+00 1.6313466875576738E-91 --- ---
- 50: 1.1999999999999980E+32 2.2992617197398931E+07 1.0313305289730867E+01 2.1729968967757921E+09 5.2930678813769138E+08 1.3647226441359330E+27 1.6673131507245732E+18 8.7215010625432321E-01 0.0000000000000000E+00 1.3734342486398676E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.2584740844723559E-12 4.9743924848120979E-01 0.0000000000000000E+00 4.9832029593055210E-01 4.2250678462084166E-03 1.5386081279736222E-05 1.6584847383522823E-09 3.5096073171959367E-16 4.0824433994458689E-24 8.9851204301876912E-34 3.1402837224389655E-45 1.0033696434898093E-58 1.7869517632250329E-73 0.0000000000000000E+00 1.6272617863194366E-91 --- ---
- 51: 1.2699093329921292E+32 2.3471155729097106E+07 1.0526468438148841E+01 2.1538927442182555E+09 5.2649344241052461E+08 1.3486610462717586E+27 1.6617754875348344E+18 8.7231658332565964E-01 0.0000000000000000E+00 1.3734339303700443E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.2359772661541257E-12 4.9743965375132815E-01 0.0000000000000000E+00 4.9832056278046516E-01 4.2243990726565468E-03 1.5382735542627256E-05 1.6577647943213821E-09 3.5074465330681041E-16 4.0790144246910306E-24 8.9754385140805396E-34 3.1359841196680297E-45 1.0016349152542071E-58 1.7832531696116540E-73 0.0000000000000000E+00 1.6233910845143217E-91 --- ---
- 52: 1.3389094018350411E+32 2.3928908146455970E+07 1.0730286840314662E+01 2.1354905318749774E+09 5.2377432420333862E+08 1.3332350781141139E+27 1.6564105902595515E+18 8.7247870046709275E-01 0.0000000000000000E+00 1.3734336269184910E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.2142393452873078E-12 4.9744004015416410E-01 0.0000000000000000E+00 4.9832081719889498E-01 4.2237614473654176E-03 1.5379540274247849E-05 1.6570802586714499E-09 3.5053907761473034E-16 4.0757552658523024E-24 8.9662419949447887E-34 3.1319036324138857E-45 9.9998996393513992E-59 1.7797468317251879E-73 0.0000000000000000E+00 1.6197220000897649E-91 --- ---
- 53: 1.4072171717118605E+32 2.4369046227081340E+07 1.0926181773608848E+01 2.1176871088392270E+09 5.2113504955275100E+08 1.3183537748850660E+27 1.6511911767975245E+18 8.7263721225490043E-01 0.0000000000000000E+00 1.3734333361461758E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1931585457538847E-12 4.9744041041319031E-01 0.0000000000000000E+00 4.9832106098059364E-01 4.2231504736156590E-03 1.5376473974528852E-05 1.6564259002957131E-09 3.5034246038432676E-16 4.0726407458150946E-24 8.9574584836975645E-34 3.1280092900273758E-45 9.9842115826841164E-59 1.7764034997047596E-73 0.0000000000000000E+00 1.6162238509946259E-91 --- ---
- 54: 1.4750432780659248E+32 2.4794304725967374E+07 1.1115377786310523E+01 2.1003913815631516E+09 5.1856281868152028E+08 1.3039372965481135E+27 1.6460928296056753E+18 8.7279280343516585E-01 0.0000000000000000E+00 1.3734330562028754E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1726430069041236E-12 4.9744076688418842E-01 0.0000000000000000E+00 4.9832129567786743E-01 4.2225622620165664E-03 1.5373517950777035E-05 1.6557972385756385E-09 3.5015347649182259E-16 4.0696493358120470E-24 8.9490262341544754E-34 3.1242730705238040E-45 9.9691695517634522E-59 1.7731984307785665E-73 0.0000000000000000E+00 1.6128706927784414E-91 --- ---
- 55: 1.5425939774471797E+32 2.5207074672137003E+07 1.1298944639403684E+01 2.0835219116955106E+09 5.1604609408823305E+08 1.2899147380070879E+27 1.6410934029313656E+18 8.7294610427238895E-01 0.0000000000000000E+00 1.3734327854696128E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1526091025394602E-12 4.9744111162852545E-01 0.0000000000000000E+00 4.9832152264890595E-01 4.2219934094511391E-03 1.5370655767711482E-05 1.6551903880200487E-09 3.4997097483769613E-16 4.0667623940702369E-24 8.9408918994683447E-34 3.1206708414950804E-45 9.9546744581959666E-59 1.7701104047545088E-73 0.0000000000000000E+00 1.6096402821601144E-91 --- ---
- 56: 1.6100730319096502E+32 2.5609474847148426E+07 1.1477829424427558E+01 2.0670050220070577E+09 5.1357434520640296E+08 1.2762224101380104E+27 1.6361725485298207E+18 8.7309770294102707E-01 0.0000000000000000E+00 1.3734325225136780E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1329800521438664E-12 4.9744144647042399E-01 0.0000000000000000E+00 4.9832174309555083E-01 4.2214409044687160E-03 1.5367872814865122E-05 1.6546019385308191E-09 3.4979394351810659E-16 4.0639635809929558E-24 8.9330088154677799E-34 3.1171815544297514E-45 9.9406401236912650E-59 1.7671209812118116E-73 0.0000000000000000E+00 1.6065132956640103E-91 --- ---
- 57: 1.6776835556955623E+32 2.6003407623872489E+07 1.1652881639708864E+01 2.0507732741278057E+09 5.1113784160748637E+08 1.2628024661088727E+27 1.6313113303241864E+18 8.7324815579407089E-01 0.0000000000000000E+00 1.3734322660528402E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.1136847517839053E-12 4.9744177304252213E-01 0.0000000000000000E+00 4.9832195809333801E-01 4.2209020520302936E-03 1.5365155960201923E-05 1.6540288614540779E-09 3.4962148244419645E-16 4.0612384016676362E-24 8.9253356626795830E-34 3.1137866201731350E-45 9.9269906345153530E-59 1.7642139280303692E-73 0.0000000000000000E+00 1.6034727289010857E-91 --- ---
- 58: 1.7456298521421902E+32 2.6390603411288794E+07 1.1824873132809772E+01 2.0347642224986639E+09 5.0872748206745958E+08 1.2496017850215114E+27 1.6264919028264717E+18 8.7339799609891045E-01 0.0000000000000000E+00 1.3734320149265573E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0946567854749787E-12 4.9744209282252783E-01 0.0000000000000000E+00 4.9832216861566625E-01 4.2203744129663988E-03 1.5362493269721347E-05 1.6534684349463683E-09 3.4945278154958051E-16 4.0585738433960805E-24 8.9178354097915319E-34 3.1104694181847777E-45 9.9136582732845925E-59 1.7613747753634754E-73 0.0000000000000000E+00 1.6005034279937821E-91 --- ---
- 59: 1.8141192685407427E+32 2.6772656689418867E+07 1.1994514253421073E+01 2.0189193759282553E+09 5.0633465038170511E+08 1.2365710498814305E+27 1.6216972377556250E+18 8.7354774167106775E-01 0.0000000000000000E+00 1.3734317680723171E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0758335673614205E-12 4.9744240716334059E-01 0.0000000000000000E+00 4.9832237555365522E-01 4.2198557542279741E-03 1.5359873775497794E-05 1.6529181834407164E-09 3.4928710307787175E-16 4.0559580824513522E-24 8.9104744617500507E-34 3.1072149027676705E-45 9.9005818676551557E-59 1.7585904600650499E-73 0.0000000000000000E+00 1.5975917162396834E-91 --- ---
- 60: 1.8833640970564785E+32 2.7151055776355702E+07 1.2162467178191497E+01 2.0031833164733226E+09 5.0395109118009037E+08 1.2236639738929761E+27 1.6169108826357268E+18 8.7369790172618922E-01 0.0000000000000000E+00 1.3734315245065233E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0571556368646219E-12 4.9744271731738909E-01 0.0000000000000000E+00 4.9832257973218952E-01 4.2193440086941659E-03 1.5357287287495726E-05 1.6523758291710706E-09 3.4912376737944007E-16 4.0533802496932400E-24 8.9032219804727768E-34 3.1040092901926957E-45 9.8877054830550153E-59 1.7558490445283846E-73 0.0000000000000000E+00 1.5947250990373314E-91 --- ---
- 61: 1.9535835507965445E+32 2.7527207896192808E+07 1.2329357113108133E+01 1.9875029380506003E+09 5.0156880071605474E+08 1.2108366408770505E+27 1.6121167528365023E+18 8.7384898320813498E-01 0.0000000000000000E+00 1.3734312833075856E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0385659782208058E-12 4.9744302445815758E-01 0.0000000000000000E+00 4.9832278192410712E-01 4.2188372396251960E-03 1.5354724225491985E-05 1.6518392500310051E-09 3.4896214052540272E-16 4.0508302273857386E-24 8.8960492983955610E-34 3.1008397901368920E-45 9.8749773069137370E-59 1.7531394771075984E-73 0.0000000000000000E+00 1.5918920126139162E-91 --- ---
- 62: 2.0250058457133319E+32 2.7902460720081035E+07 1.2495781899338116E+01 1.9718267761339855E+09 4.9917992867380428E+08 1.1980469339602784E+27 1.6072989315441600E+18 8.7400149679011419E-01 0.0000000000000000E+00 1.3734310436019475E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0200094565156464E-12 4.9744332969797811E-01 0.0000000000000000E+00 4.9832298286192572E-01 4.2183336112833654E-03 1.5352175479613497E-05 1.6513064450209202E-09 3.4880162413912918E-16 4.0482984828779740E-24 8.8889294394366165E-34 3.0976943869853742E-45 9.8623487429088149E-59 1.7504513978351093E-73 0.0000000000000000E+00 1.5890816203543767E-91 --- ---
- 63: 2.0978704213002423E+32 2.8278121274531718E+07 1.2662320422917261E+01 1.9561044062965140E+09 4.9677668792093843E+08 1.1852540327048149E+27 1.6024414901104561E+18 8.7415596272137397E-01 0.0000000000000000E+00 1.3734308045517881E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0014323032981468E-12 4.9744363410368792E-01 0.0000000000000000E+00 4.9832318324816072E-01 4.2178313630808839E-03 1.5349632286812482E-05 1.6507755663401244E-09 3.4864164657015203E-16 4.0457759243711349E-24 8.8818367048327205E-34 3.0945616515542435E-45 9.8497736344772831E-59 1.7477749720848542E-73 0.0000000000000000E+00 1.5862836385313874E-91 --- ---
- 64: 2.1724303360364681E+32 2.8655472914132919E+07 1.2829540140581262E+01 1.9402858939989336E+09 4.9435126969125497E+08 1.1724179632534488E+27 1.5975283127400763E+18 8.7431291666988997E-01 0.0000000000000000E+00 1.3734305653440714E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.9827816488160516E-12 4.9744393871057380E-01 0.0000000000000000E+00 4.9832338376451335E-01 4.2173287865587359E-03 1.5347086119986492E-05 1.6502447593462241E-09 3.4848165501237954E-16 4.0432537742187134E-24 8.8747463103709925E-34 3.0914305768332469E-45 9.8372075900457098E-59 1.7451007462108245E-73 0.0000000000000000E+00 1.5834881851561284E-91 --- ---
- 65: 2.2489548773511207E+32 2.9035790915666625E+07 1.2998003968957972E+01 1.9243212814416847E+09 4.9189576210213304E+08 1.1594991893538282E+27 1.5925429234892572E+18 8.7447291569889263E-01 0.0000000000000000E+00 1.3734303251806040E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.9640050939374433E-12 4.9744424453502878E-01 0.0000000000000000E+00 4.9832358508020946E-01 4.2168242044922141E-03 1.5344528586866742E-05 1.6497122123365729E-09 3.4832110851940788E-16 4.0407234554562992E-24 8.8676340624035264E-34 3.0882904318552264E-45 9.8246073850095647E-59 1.7424195197728943E-73 0.0000000000000000E+00 1.5806856462916468E-91 --- ---
- 66: 2.3277324306118210E+32 2.9420357151040591E+07 1.3168276740931024E+01 1.9081600998227203E+09 4.8940207020089191E+08 1.1464582346155811E+27 1.5874683156103862E+18 8.7463654450938977E-01 0.0000000000000000E+00 1.3734300832689692E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.9450503270783368E-12 4.9744455258609588E-01 0.0000000000000000E+00 4.9832378785960380E-01 4.2163159518353952E-03 1.5341951337235396E-05 1.6491761347129215E-09 3.4815947164986661E-16 4.0381764895427940E-24 8.8604760666240962E-34 3.0851306308013896E-45 9.8119304279216167E-59 1.7397222316305581E-73 0.0000000000000000E+00 1.5778665569696286E-91 --- ---
- 67: 2.4090736574335975E+32 2.9810474226649445E+07 1.3340931399287616E+01 1.8917508972456448E+09 4.8686183594572198E+08 1.1332553282930342E+27 1.5822867734236859E+18 8.7480442208463194E-01 0.0000000000000000E+00 1.3734298388137866E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.9258647573217597E-12 4.9744486387660325E-01 0.0000000000000000E+00 4.9832399276951500E-01 4.2158023573416487E-03 1.5339345972841305E-05 1.6486347362430645E-09 3.4799620839593169E-16 4.0356043990621327E-24 8.8532484517717490E-34 3.0819406092997443E-45 9.7991342579461885E-59 1.7369998528606322E-73 0.0000000000000000E+00 1.5750214893383644E-91 --- ---
- 68: 2.4933150406163306E+32 3.0207479429476190E+07 1.3516555076859532E+01 1.8750407739581003E+09 4.8426635664587730E+08 1.1198500684254164E+27 1.5769796887296461E+18 8.7497720887602415E-01 0.0000000000000000E+00 1.3734295910083985E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.9063951864073939E-12 4.9744517943374078E-01 0.0000000000000000E+00 4.9832420048619108E-01 4.2152817261074263E-03 1.5336703961419000E-05 1.6480862075971612E-09 3.4783077646040230E-16 4.0329986163182746E-24 8.8459271106959454E-34 3.0787097088713964E-45 9.7861760769368612E-59 1.7342432871924609E-73 0.0000000000000000E+00 1.5721409487632795E-91 --- ---
- 69: 2.5808228614584748E+32 3.0612758790595118E+07 1.3695755197619084E+01 1.8579749177129591E+09 4.8160650047646827E+08 1.1062010974439114E+27 1.5715273657248082E+18 8.7515561468352876E-01 0.0000000000000000E+00 1.3734293390266524E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8865875051195768E-12 4.9744550030953150E-01 0.0000000000000000E+00 4.9832441170220593E-01 4.2147523222893137E-03 1.5334016551127364E-05 1.6475287013052995E-09 3.4766262163394505E-16 4.0303503938366580E-24 8.8384874474432927E-34 3.0754270644318707E-45 9.7730122953697163E-59 1.7314432745298262E-73 0.0000000000000000E+00 1.5692152732497817E-91 --- ---
- 70: 2.6719976853101119E+32 3.1027761561612312E+07 1.3879165724991767E+01 1.8404961329199417E+09 4.7887261770905876E+08 1.0922657864567133E+27 1.5659088110290132E+18 8.7534040739983388E-01 0.0000000000000000E+00 1.3734290820146272E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8663864181479897E-12 4.9744582759136258E-01 0.0000000000000000E+00 4.9832462713339337E-01 4.2142123517262984E-03 1.5331274684139898E-05 1.6469603128079661E-09 3.4749117218026451E-16 4.0276507152671711E-24 8.8309041260441438E-34 3.0720814928799618E-45 9.7595980840144503E-59 1.7285902958287143E-73 0.0000000000000000E+00 1.5662345343847829E-91 --- ---
- 71: 2.7672794433236437E+32 3.1454015397137836E+07 1.4067453681681330E+01 1.8225443579785490E+09 4.7605444630112654E+08 1.0779999254359950E+27 1.5601015054983575E+18 8.7553242281238308E-01 0.0000000000000000E+00 1.3734288190821262E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8457351975858575E-12 4.9744616241282114E-01 0.0000000000000000E+00 4.9832484752598250E-01 4.2136599440572879E-03 1.5328468907377824E-05 1.6463790611337178E-09 3.4731583309401236E-16 4.0248902045230403E-24 8.8231508148541941E-34 3.0686613800223915E-45 9.7458869201647700E-59 1.7256744769557569E-73 0.0000000000000000E+00 1.5631884373242576E-91 --- ---
- 72: 2.8671532128046399E+32 3.1893142545798276E+07 1.4261326067216244E+01 1.8040561658126369E+09 4.7314101044812608E+08 1.0633574175177146E+27 1.5540811536771369E+18 8.7573257568479623E-01 0.0000000000000000E+00 1.3734285492938435E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8245754762705378E-12 4.9744650596494239E-01 0.0000000000000000E+00 4.9832507366400303E-01 4.2130931341607964E-03 1.5325589279564106E-05 1.6457828689972067E-09 3.4713598017324543E-16 4.0220590322154789E-24 8.8151999237756924E-34 3.0651545646299054E-45 9.7318301235230130E-59 1.7226854904929790E-73 0.0000000000000000E+00 1.5600662187596101E-91 --- ---
- 73: 2.9721558158067136E+32 3.2346877373627927E+07 1.4461537306978341E+01 1.7849642432310605E+09 4.7012051064154309E+08 1.0482899766592943E+27 1.5478214059931343E+18 8.7594187238057164E-01 0.0000000000000000E+00 1.3734282716599532E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.8028470818764258E-12 4.9744685950818973E-01 0.0000000000000000E+00 4.9832530637717304E-01 4.2125098423862603E-03 1.5322625271948381E-05 1.6451695417418404E-09 3.4695095373621320E-16 4.0191468166907519E-24 8.8070223267818178E-34 3.0615482162721837E-45 9.7173763682797465E-59 1.7196124526415754E-73 0.0000000000000000E+00 1.5568565399065461E-91 --- ---
- 74: 3.0828833761965824E+32 3.2817085577833802E+07 1.4668897378605715E+01 1.7651968453645298E+09 4.6698020368027115E+08 1.0327468290378902E+27 1.5412935486245202E+18 8.7616142533897701E-01 0.0000000000000000E+00 1.3734279851260593E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7804879311155242E-12 4.9744722438525790E-01 0.0000000000000000E+00 4.9832554654932731E-01 4.2119078534288961E-03 1.5319565661985067E-05 1.6445367449599438E-09 3.4676005193500498E-16 4.0161425189185902E-24 8.7985870676448287E-34 3.0578287060077029E-45 9.7024711677210414E-59 1.7164438144668165E-73 0.0000000000000000E+00 1.5535473737486842E-91 --- ---
- 75: 3.1999999999999984E+32 3.3305785497741677E+07 1.4884280780466488E+01 1.7446772221513269E+09 4.6370627097716182E+08 1.0166744198948245E+27 1.5344661550208794E+18 8.7639246977395391E-01 0.0000000000000000E+00 1.3734276885621480E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7574339872579988E-12 4.9744760203513938E-01 0.0000000000000000E+00 4.9832579512767783E-01 4.2112847931202717E-03 1.5316398416293027E-05 1.6438819800186238E-09 3.4656252343587233E-16 4.0130343276137187E-24 8.7898610387381022E-34 3.0539814654748671E-45 9.6870563136011207E-59 1.7131672437369874E-73 0.0000000000000000E+00 1.5501258826526965E-91 --- ---
- 76: 3.3242477732292700E+32 3.3815171996174984E+07 1.5108637087899226E+01 1.7233230144522974E+09 4.6028368321956438E+08 1.0000161291133041E+27 1.5273046922127086E+18 8.7663638445695691E-01 0.0000000000000000E+00 1.3734273807552414E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7336196815677753E-12 4.9744799400247763E-01 0.0000000000000000E+00 4.9832605312897077E-01 4.2106381129955886E-03 1.5313110613051261E-05 1.6432025678494387E-09 3.4635756259352446E-16 4.0098095838073993E-24 8.7808087711222709E-34 3.0499908953384945E-45 9.6710695146149618E-59 1.7097695493237290E-73 0.0000000000000000E+00 1.5465783406531354E-91 --- ---
- 77: 3.4558346558849076E+32 3.4345153652122110E+07 1.5341905663740597E+01 1.7010999130878603E+09 4.5670453555975276E+08 9.8275408062036801E+26 1.5197895122300042E+18 8.7689404150991612E-01 0.0000000000000000E+00 1.3734270611759628E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7090380752393380E-12 4.9744840096141146E-01 0.0000000000000000E+00 4.9832632099696395E-01 4.2099667007798706E-03 1.5309696631778222E-05 1.6424973406265473E-09 3.4614481983963716E-16 4.0064628107376362E-24 8.7714149753531157E-34 3.0458503020827693E-45 9.6544842051866541E-59 1.7062451421212497E-73 0.0000000000000000E+00 1.5428989678430963E-91 --- ---
- 78: 3.5949549650650617E+32 3.4895593286262311E+07 1.5584003866661156E+01 1.6780246139662335E+09 4.5296942408363962E+08 9.6491071112104617E+26 1.5119174206177687E+18 8.7716584307861112E-01 0.0000000000000000E+00 1.3734267299914368E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6837407555172619E-12 4.9744882269913893E-01 0.0000000000000000E+00 4.9832659859162270E-01 4.2092709074842225E-03 1.5306158297071525E-05 1.6417666681179342E-09 3.4592440958022606E-16 4.0029958331427286E-24 8.7616848640752107E-34 3.0415620338125519E-45 9.6373100596493429E-59 1.7025961385499869E-73 0.0000000000000000E+00 1.5390900328992804E-91 --- ---
- 79: 3.7417875542041018E+32 3.5466311121490113E+07 1.5834829751578553E+01 1.6541178350885830E+09 4.4907926862612486E+08 9.4651182271718333E+26 1.5036861387437079E+18 8.7745214395878568E-01 0.0000000000000000E+00 1.3734263874005153E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6577861134085579E-12 4.9744925896245268E-01 0.0000000000000000E+00 4.9832688574632800E-01 4.2085511507664198E-03 1.5302497777332561E-05 1.6410109903168734E-09 3.4569646747551905E-16 3.9994108112106866E-24 8.7516245955423394E-34 3.0371288579793467E-45 9.6195584444924821E-59 1.6988250168298126E-73 0.0000000000000000E+00 1.5351541842596292E-91 --- ---
- 80: 3.8964939972735609E+32 3.6057088035442501E+07 1.6094262923249254E+01 1.6294042458490174E+09 4.4503554705231148E+08 9.2758644487331281E+26 1.4950943227155279E+18 8.7775328297194466E-01 0.0000000000000000E+00 1.3734260336265818E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6312386763588508E-12 4.9744970946690514E-01 0.0000000000000000E+00 4.9832718227390665E-01 4.2078078998130809E-03 1.5298717506195322E-05 1.6402308018573998E-09 3.4546114569725915E-16 3.9957101662397790E-24 8.7412410650524354E-34 3.0325538693999095E-45 9.6012420490098372E-59 1.6949345381973626E-73 0.0000000000000000E+00 1.5310943675810350E-91 --- ---
- 81: 4.0592167942119814E+32 3.6667668819922432E+07 1.6362166006781550E+01 1.6039123637399015E+09 4.4084029568348169E+08 9.0816666449588950E+26 1.4861415778800384E+18 8.7806958156552906E-01 0.0000000000000000E+00 1.3734256689151630E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.6041687449904596E-12 4.9745017389985052E-01 0.0000000000000000E+00 4.9832748796863024E-01 4.2070416703262753E-03 1.5294820155384863E-05 1.6394266469812947E-09 3.4521861137549620E-16 3.9918965563907268E-24 8.7305418368240806E-34 3.0278404600898775E-45 9.5823747632535251E-59 1.6909277206596547E-73 0.0000000000000000E+00 1.5269137980327083E-91 --- ---
- 82: 4.2300776145254535E+32 3.7297765371557370E+07 1.6638386091609480E+01 1.5776744203866003E+09 4.3649610645994145E+08 8.8828742646530088E+26 1.4768284687400218E+18 8.7840134233185796E-01 0.0000000000000000E+00 1.3734252935315942E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5766519733941448E-12 4.9745065192341731E-01 0.0000000000000000E+00 4.9832780260816983E-01 4.2062530196219925E-03 1.5290808608292565E-05 1.6385991145498028E-09 3.4496904506583926E-16 3.9879728526608955E-24 8.7195350763201645E-34 3.0229922892038658E-45 9.5629715561229428E-59 1.6868078127562822E-73 0.0000000000000000E+00 1.5226159325835932E-91 --- ---
- 83: 4.4091755965041985E+32 3.7947059748770811E+07 1.6922756118313970E+01 1.5507261987805278E+09 4.3200612096380568E+08 8.6798630726224786E+26 1.4671565255904622E+18 8.7874884742810488E-01 0.0000000000000000E+00 1.3734249077589473E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5487689186115319E-12 4.9745114317714600E-01 0.0000000000000000E+00 4.9832812595532910E-01 4.2054425422839922E-03 1.5286685936593877E-05 1.6377488335638609E-09 3.4471263937696318E-16 3.9839421172774090E-24 8.7082294891910145E-34 3.0180132558127020E-45 9.5430483645731325E-59 1.6825782696666335E-73 0.0000000000000000E+00 1.5182044447239819E-91 --- ---
- 84: 4.5965857198159911E+32 3.8615207041439749E+07 1.7215096185796330E+01 1.5231068437543137E+09 4.2737402143919694E+08 8.4730326457289374E+26 1.4571282470390474E+18 8.7911235688329037E-01 0.0000000000000000E+00 1.3734245118961244E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5206045631637262E-12 4.9745164728041946E-01 0.0000000000000000E+00 4.9832845775964252E-01 4.2046108661553923E-03 1.5282455378846631E-05 1.6368764689686810E-09 3.4444959769010870E-16 3.9798075834418801E-24 8.6966342638605583E-34 3.0129074732210468E-45 9.5226219888073687E-59 1.6782427305742984E-73 0.0000000000000000E+00 1.5136832004877681E-91 --- ---
- 85: 4.7923572693506620E+32 3.9301838010894105E+07 1.7515214759641964E+01 1.4948586478866711E+09 4.2260401894365722E+08 8.2628036595494752E+26 1.4467470996031982E+18 8.7949210677750300E-01 0.0000000000000000E+00 1.3734241062561955E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4922478300170671E-12 4.9745216383457713E-01 0.0000000000000000E+00 4.9832879775876465E-01 4.2037586488548034E-03 1.5278120322038809E-05 1.6359827179476366E-09 3.4418013303133616E-16 3.9755726373940855E-24 8.6847590204943560E-34 3.0076792460479256E-45 9.5017099984020386E-59 1.6738049983418450E-73 0.0000000000000000E+00 1.5090562368754761E-91 --- ---
- 86: 4.9965124080893332E+32 4.0006561468729779E+07 1.7822909767954268E+01 1.4660268151366422E+09 4.1770083876257217E+08 8.0496149979816735E+26 1.4360175138469535E+18 8.7988830728248424E-01 0.0000000000000000E+00 1.3734236911649859E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4637911026815751E-12 4.9745269242471735E-01 0.0000000000000000E+00 4.9832914567965580E-01 4.2028865748023623E-03 1.5273684286005488E-05 1.6350683067019841E-09 3.4390446709420469E-16 3.9712408027734556E-24 8.6726137663179602E-34 3.0023330500716411E-45 9.4803306494162823E-59 1.6692690215087564E-73 0.0000000000000000E+00 1.5043277426922170E-91 --- ---
- 87: 5.2090448764490796E+32 4.0728966372918896E+07 1.8137969576029004E+01 1.4366592045965915E+09 4.1266970321497840E+08 7.8339207192353630E+26 1.4249448777275366E+18 8.8030114055424291E-01 0.0000000000000000E+00 1.3734232669599228E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4353297649590684E-12 4.9745323262116459E-01 0.0000000000000000E+00 4.9832950123954656E-01 4.2019953528022579E-03 1.5269150910926143E-05 1.6341339877784239E-09 3.4362282943023134E-16 3.9668157275680282E-24 8.6602088581253205E-34 2.9968735152220971E-45 9.4585028140548252E-59 1.6646388789464848E-73 0.0000000000000000E+00 1.4995020421492720E-91 --- ---
- 88: 5.4299188350019514E+32 4.1468623628680266E+07 1.8460173833863628E+01 1.4068060568277600E+09 4.0751631197626156E+08 7.6161869124015315E+26 1.4135355271632916E+18 8.8073075847270643E-01 0.0000000000000000E+00 1.3734228339891210E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4069617704050251E-12 4.9745378398063300E-01 0.0000000000000000E+00 4.9832986414670322E-01 4.2010857141224246E-03 1.5264523947559995E-05 1.6331805378952132E-09 3.4333545679100096E-16 3.9623011734137288E-24 8.6475549713368000E-34 2.9913054114490390E-45 9.4362459218229002E-59 1.6599187669459367E-73 0.0000000000000000E+00 1.4945835809952297E-91 --- ---
- 89: 5.6590678666849841E+32 4.2225087589398749E+07 1.8789294196421874E+01 1.3765197053013132E+09 4.0224682004061830E+08 7.3968884791699254E+26 1.4017967336343747E+18 8.8117728022579356E-01 0.0000000000000000E+00 1.3734223926106857E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3787872507319822E-12 4.9745434604711503E-01 0.0000000000000000E+00 4.9833023410101279E-01 4.2001584110284654E-03 1.5259807249952360E-05 1.6322087562332711E-09 3.4304259261073154E-16 3.9577010070826214E-24 8.6346630751746361E-34 2.9856336372834570E-45 9.4135799114575017E-59 1.6551129885858479E-73 0.0000000000000000E+00 1.4895769150188763E-91 --- ---
- 90: 5.8963941536053810E+32 4.2997897259512015E+07 1.9125094916132305E+01 1.3458542755169754E+09 3.9686781344289553E+08 7.1765058753180187E+26 1.3897366896184535E+18 8.8164078973881832E-01 0.0000000000000000E+00 1.3734219431923341E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3509081779544477E-12 4.9745491835236322E-01 0.0000000000000000E+00 4.9833061079430008E-01 4.1992142159885037E-03 1.5255004771663332E-05 1.6312194634286588E-09 3.4274448669967449E-16 3.9530191952771565E-24 8.6215444171008142E-34 2.9798632124799881E-45 9.3905251991859791E-59 1.6502259465587329E-73 0.0000000000000000E+00 1.4844867021494970E-91 --- ---
- 91: 6.1417678423078713E+32 4.3786577206747979E+07 1.9467333313937807E+01 1.3148653744096656E+09 3.9138628286759800E+08 6.9555218463100790E+26 1.3773644910767488E+18 8.8212133295625950E-01 0.0000000000000000E+00 1.3734214861111051E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3234280702979773E-12 4.9745550041626196E-01 0.0000000000000000E+00 4.9833099391057301E-01 4.1982539210588298E-03 1.5250120562977848E-05 1.6302135007594388E-09 3.4244139499494295E-16 3.9482598003289441E-24 8.6082105097956661E-34 2.9739992717843975E-45 9.3671026514955345E-59 1.6452621369481859E-73 0.0000000000000000E+00 1.4793176955429316E-91 --- ---
- 92: 6.3950266099171614E+32 4.4590638195472263E+07 1.9815760132676143E+01 1.2836097726821356E+09 3.8580959526679510E+08 6.7344181907264933E+26 1.3646901177789647E+18 8.8261891498387257E-01 0.0000000000000000E+00 1.3734210217533805E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2964517577370591E-12 4.9745609174679273E-01 0.0000000000000000E+00 4.9833138312600017E-01 4.1972783379409396E-03 1.5245158771551176E-05 1.6291917300452835E-09 3.4213357952461674E-16 3.9434269792552192E-24 8.5946731275565756E-34 2.9680470628523415E-45 9.3433335745005704E-59 1.6402261465196615E-73 0.0000000000000000E+00 1.4740747403221974E-91 --- ---
- 93: 6.6559754419100693E+32 4.5409577556306414E+07 2.0170119782467541E+01 1.2521450827170007E+09 3.8014546362342203E+08 6.5136725842930403E+26 1.3517244110038909E+18 8.8313349710782318E-01 0.0000000000000000E+00 1.3734205505150097E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2700851877196519E-12 4.9745669183988672E-01 0.0000000000000000E+00 4.9833177810881424E-01 4.1962882982236613E-03 1.5240123643983842E-05 1.6281550337523112E-09 3.4182130843201353E-16 3.9385249837707844E-24 8.5809443053857801E-34 2.9620119453568041E-45 9.3192397080613070E-59 1.6351226510126589E-73 0.0000000000000000E+00 1.4687627713555317E-91 --- ---
- 94: 6.9243866304249961E+32 4.6242879309735492E+07 2.0530150484864453E+01 1.2205294347234173E+09 3.7440191499687171E+08 6.2937554959944111E+26 1.3384790489826437E+18 8.8366499370909379E-01 0.0000000000000000E+00 1.3734200728016560E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2444352666685797E-12 4.9745730017897200E-01 0.0000000000000000E+00 4.9833217851901490E-01 4.1952846541280977E-03 1.5235019529918890E-05 1.6271043156362961E-09 3.4150485616049090E-16 3.9335581628318891E-24 8.5670363451821318E-34 2.9558993932235603E-45 9.2948432323913858E-59 1.6299564160736789E-73 0.0000000000000000E+00 1.4633868137787577E-91 --- ---
- 95: 7.1999999999999965E+32 4.7090014063278563E+07 2.0895584326964094E+01 1.1888211537577033E+09 3.6858725700431061E+08 6.0751272261276568E+26 1.3249665198683666E+18 8.8421326909951270E-01 0.0000000000000000E+00 1.3734195890292280E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2196097006248220E-12 4.9745791623443258E-01 0.0000000000000000E+00 4.9833258400801334E-01 4.1942682794009287E-03 1.5229850886844761E-05 1.6260405015521387E-09 3.4118450368676879E-16 3.9285309659524040E-24 8.5529618241044741E-34 2.9497149978235069E-45 9.2701667784759669E-59 1.6247322989908280E-73 0.0000000000000000E+00 1.4579519843470584E-91 --- ---
- 96: 7.4825233654680658E+32 4.7950438703088038E+07 2.1266147235003881E+01 1.1570784402250314E+09 3.6271004289526308E+08 5.8582350942089192E+26 1.3112000923989804E+18 8.8477813430945063E-01 0.0000000000000000E+00 1.3734190996244717E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1957167931026920E-12 4.9745853946284913E-01 0.0000000000000000E+00 4.9833299421813265E-01 4.1932400705650703E-03 1.5224622286660410E-05 1.6249645406468607E-09 3.4086053886838789E-16 3.9234479483206511E-24 8.5387336079833232E-34 2.9434644733845484E-45 9.2452334473363102E-59 1.6194552522969072E-73 0.0000000000000000E+00 1.4524634947268525E-91 --- ---
- 97: 7.7716466101759362E+32 4.8823636178747430E+07 2.1641576178982589E+01 1.1253583101211379E+09 3.5677889512575465E+08 5.6435057742536555E+26 1.2971934516867850E+18 8.8535935773996099E-01 0.0000000000000000E+00 1.3734186050137328E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1728645638791111E-12 4.9745916932131207E-01 0.0000000000000000E+00 4.9833340879202992E-01 4.1922009233057713E-03 1.5219338295750480E-05 1.6238773805468016E-09 3.4053324896095017E-16 3.9183136530887520E-24 8.5243645209854376E-34 2.9371535114280553E-45 9.2200662272128402E-59 1.6141301999759102E-73 0.0000000000000000E+00 1.4469265223177579E-91 --- ---
- 98: 8.0670300945172416E+32 4.9709076029030949E+07 2.2021602217143656E+01 1.0937163583067205E+09 3.5080247393361044E+08 5.4313435543130304E+26 1.2829606647774548E+18 8.8595666277839769E-01 0.0000000000000000E+00 1.3734181056244338E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1511603832731708E-12 4.9745980526553946E-01 0.0000000000000000E+00 4.9833382737145721E-01 4.1911517355751127E-03 1.5214003490904174E-05 1.6227799705391678E-09 3.4020292156888406E-16 3.9131326260955788E-24 8.5098673862989351E-34 2.9307877983666317E-45 9.1946880624360498E-59 1.6087620517702712E-73 0.0000000000000000E+00 1.4413462248770291E-91 --- ---
- 99: 8.3683057110728352E+32 5.0606213568678215E+07 2.2405950267082982E+01 1.0622072000954221E+09 3.4478957323575866E+08 5.2221332083050306E+26 1.2685164523572403E+18 8.8656971236125215E-01 0.0000000000000000E+00 1.3734176018967075E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1307104959492384E-12 4.9746044673506040E-01 0.0000000000000000E+00 4.9833424958751021E-01 4.1900934320355260E-03 1.5208622583676122E-05 1.6216732870607723E-09 3.3986985230687656E-16 3.9079095357865196E-24 8.4952553609901996E-34 2.9243731621728496E-45 9.1691224363603483E-59 1.6033558261208164E-73 0.0000000000000000E+00 1.4357278679687544E-91 --- ---
- 100: 8.6750781544790573E+32 5.1514488961992152E+07 2.2794338840446823E+01 1.0308842036473421E+09 3.3874908423998672E+08 5.0162380932350264E+26 1.2538761536649280E+18 8.8719810593456805E-01 0.0000000000000000E+00 1.3734170942842852E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1116181963765646E-12 4.9746109315208775E-01 0.0000000000000000E+00 4.9833467505988588E-01 4.1890269659202433E-03 1.5203200429866124E-05 1.6205583355521259E-09 3.3953434534343831E-16 3.9026491814364861E-24 8.4805419581426674E-34 2.9179155816357051E-45 9.1433934059911638E-59 1.5979166570246845E-73 0.0000000000000000E+00 1.4300768316467524E-91 --- ---
- 101: 8.9869263997885493E+32 5.2433326203369550E+07 2.3186479750852438E+01 9.9979923627975464E+08 3.3268995860561305E+08 4.8139984795554594E+26 1.2390556894490918E+18 8.8784137657813511E-01 0.0000000000000000E+00 1.3734165832554028E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0939807589615851E-12 4.9746174392036002E-01 0.0000000000000000E+00 4.9833510339612114E-01 4.1879533209432333E-03 1.5197742039220468E-05 1.6194361523648891E-09 3.3919671396008872E-16 3.8973565016195116E-24 8.4657410696842870E-34 2.9114211959182131E-45 9.1175256378065921E-59 1.5924498011451843E-73 0.0000000000000000E+00 1.4243986173994244E-91 --- ---
- 102: 9.3034053808593111E+32 5.3362132024984516E+07 2.3582077804807692E+01 9.6900242651099491E+08 3.2662117136435735E+08 4.6157301249033225E+26 1.2240715228991736E+18 8.8849898835642116E-01 0.0000000000000000E+00 1.3734160692937039E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0778845816458030E-12 4.9746239842399509E-01 0.0000000000000000E+00 4.9833553419083804E-01 4.1868735131900033E-03 1.5192252585013106E-05 1.6183078066503912E-09 3.3885728110457378E-16 3.8920365825867672E-24 8.4508669889606962E-34 2.9048963140042648E-45 9.0915444431436051E-59 1.5869606448314838E-73 0.0000000000000000E+00 1.4186988550035389E-91 --- ---
- 103: 9.6240478581360333E+32 5.4300294752042189E+07 2.3980830485769278E+01 9.3854194348167396E+08 3.2055168382454664E+08 4.4217230982779968E+26 1.2089406187648271E+18 8.8917033396656764E-01 0.0000000000000000E+00 1.3734155528990978E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0633980961366021E-12 4.9746305602639301E-01 0.0000000000000000E+00 4.9833596702502203E-01 4.1857885929277843E-03 1.5186737413200179E-05 1.6171744021648192E-09 3.3851637991890740E-16 3.8866946662529293E-24 8.4359344322198916E-34 2.8983474236716131E-45 9.0654758117178291E-59 1.5814547107489842E-73 0.0000000000000000E+00 1.4129833089793813E-91 --- ---
- 104: 9.9483664631032995E+32 5.5247183126331754E+07 2.4382427639962032E+01 9.0846379520663059E+08 3.1449040668647629E+08 4.2322408585033557E+26 1.1936804005810906E+18 8.8985473275675131E-01 0.0000000000000000E+00 1.3734150345885656E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0505625263779926E-12 4.9746371606921380E-01 0.0000000000000000E+00 4.9833640146534919E-01 4.1846996462922992E-03 1.5181202050934942E-05 1.6160370789465540E-09 3.3817435422901837E-16 3.8813361575855873E-24 8.4209585584409409E-34 2.8917811997458272E-45 9.0393464423198632E-59 1.5759376639221916E-73 0.0000000000000000E+00 1.4072578844453552E-91 --- ---
- 105: 1.0275855904722873E+33 5.6202145119254746E+07 2.4786551175973397E+01 8.7881164690269828E+08 3.0844616360289258E+08 4.0475195876042558E+26 1.1783087061932475E+18 8.9055142919354791E-01 0.0000000000000000E+00 1.3734145148968810E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0393817581093233E-12 4.9746437787145692E-01 0.0000000000000000E+00 4.9833683706358062E-01 4.1836077968056863E-03 1.5175652214215354E-05 1.6148970148186865E-09 3.3783155898205431E-16 3.8759666311815920E-24 8.4059549869106647E-34 2.8852045113782446E-45 9.0131837696875682E-59 1.5704153169833928E-73 0.0000000000000000E+00 1.4015286321618831E-91 --- ---
- 106: 1.0605995321344584E+33 5.7164506756092735E+07 2.5192874785783630E+01 8.4962666041625488E+08 3.0242765542172271E+08 3.8677677765853401E+26 1.1628437416404728E+18 8.9125959186027581E-01 0.0000000000000000E+00 1.3734139943772439E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0298141821898733E-12 4.9746504072865438E-01 0.0000000000000000E+00 4.9833727335603184E-01 4.1825142067079294E-03 1.5170093814576550E-05 1.6137554266989589E-09 3.3748836062618974E-16 3.8705918369526100E-24 8.3909398123403272E-34 2.8786244282617951E-45 8.9870159872365608E-59 1.5648936345651909E-73 0.0000000000000000E+00 1.3958017527052701E-91 --- ---
- 107: 1.0938250759929178E+33 5.8133570974009022E+07 2.5601063699084378E+01 8.2094735554137945E+08 2.9644342534815466E+08 3.6931660580668664E+26 1.1473040334883744E+18 8.9197831306867026E-01 0.0000000000000000E+00 1.3734134736017792E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0217702600505592E-12 4.9746570391223544E-01 0.0000000000000000E+00 4.9833770986315445E-01 4.1814200780044492E-03 1.5164532964335461E-05 1.6126135716163858E-09 3.3714513740285341E-16 3.8652177044521236E-24 8.3759296162256474E-34 2.8720482252219504E-45 8.9608720634382256E-59 1.5593787363760097E-73 0.0000000000000000E+00 1.3900835992988297E-91 --- ---
- 108: 1.1272077762965457E+33 5.9108616537139766E+07 2.6010774479879696E+01 7.9280949377975166E+08 2.9050182526175922E+08 3.5238672773711799E+26 1.1317083796600099E+18 8.9270660916760636E-01 0.0000000000000000E+00 1.3734129531618230E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0151182539943237E-12 4.9746636666916177E-01 0.0000000000000000E+00 4.9833814608929666E-01 4.1803266530681758E-03 1.5158975979568904E-05 1.6114727472669076E-09 3.3680227950121666E-16 3.8598503450625748E-24 8.3609414722802908E-34 2.8654833842388000E-45 8.9347817481250582E-59 1.5538768981805360E-73 0.0000000000000000E+00 1.3843806785009764E-91 --- ---
- 109: 1.1606924042224911E+33 6.0088897033102646E+07 2.6421654876450319E+01 7.6524598484950197E+08 2.8461098341580212E+08 3.3599967910018187E+26 1.1160757990601134E+18 8.9344342162861212E-01 0.0000000000000000E+00 1.3734124336681367E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0096971434067412E-12 4.9746702822165634E-01 0.0000000000000000E+00 4.9833858152252480E-01 4.1792352150867634E-03 1.5153429382307058E-05 1.6103342924127099E-09 3.3646018916676657E-16 3.8544960534846679E-24 8.3459929499834365E-34 2.8589375956776128E-45 8.9087755758240541E-59 1.5483945521900620E-73 0.0000000000000000E+00 1.3786996503174880E-91 --- ---
- 110: 1.1942232217492810E+33 6.1073639976306722E+07 2.6833343735101309E+01 7.3828681600668347E+08 2.7877877374438357E+08 3.2016529790633039E+26 1.1004254800824488E+18 8.9418761898539323E-01 0.0000000000000000E+00 1.3734119157507637E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0053326437644854E-12 4.9746768776738343E-01 0.0000000000000000E+00 4.9833901563474203E-01 4.1781470877647340E-03 1.5147899898947215E-05 1.6091995865107299E-09 3.3611928057954106E-16 3.8491613056460427E-24 8.3311021082045401E-34 2.8524187552147775E-45 8.8828848521909575E-59 1.5429382839328989E-73 0.0000000000000000E+00 1.3730473247077552E-91 --- ---
- 111: 1.2277442597660631E+33 6.2062046044743061E+07 2.7245472346031885E+01 7.1195900386001050E+08 2.7299959380613935E+08 3.0489079560598089E+26 1.0847767095161572E+18 8.9493614438565239E-01 0.0000000000000000E+00 1.3734114000658780E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.0018518731498214E-12 4.9746834447072846E-01 0.0000000000000000E+00 4.9833944787594853E-01 4.1770636497118711E-03 1.5142394533303905E-05 1.6080700646600610E-09 3.3577998433556515E-16 3.8438528286592710E-24 8.3162876899863429E-34 2.8459350488519783E-45 8.8571419904336982E-59 1.5375149029098525E-73 0.0000000000000000E+00 1.3674307345542670E-91 --- ---
- 112: 1.2611995981071659E+33 6.3053288477239236E+07 2.7657661629647396E+01 6.8628656886377895E+08 2.6730672699259514E+08 2.9018084627257273E+26 1.0691488891263927E+18 8.9569139337965098E-01 0.0000000000000000E+00 1.3734108873390024E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9909382185347656E-13 4.9746899740776063E-01 0.0000000000000000E+00 4.9833987763801590E-01 4.1759864252432950E-03 1.5136921027906983E-05 1.6069473121794333E-09 3.3544277584244949E-16 3.8385780448190609E-24 8.3015703608332418E-34 2.8394954944545151E-45 8.8315826594325693E-59 1.5321318947460727E-73 0.0000000000000000E+00 1.3618576035428072E-91 --- ---
- 113: 1.2945336451787247E+33 6.4046512660254672E+07 2.8069522571096687E+01 6.6129053103925228E+08 2.6169429356559521E+08 2.7603769200802707E+26 1.0535613781129032E+18 8.9645022717832623E-01 0.0000000000000000E+00 1.3734103781937305E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9691526517787329E-13 4.9746964578434760E-01 0.0000000000000000E+00 4.9834030439824983E-01 4.1749167245316620E-03 1.5131486035513829E-05 1.6058326894994108E-09 3.3510806265099093E-16 3.8333433090382142E-24 8.2869677905053815E-34 2.8331077895737595E-45 8.8062372404553660E-59 1.5267956216985308E-73 0.0000000000000000E+00 1.3563344829251764E-91 --- ---
- 114: 1.3276914148488799E+33 6.5040835934041105E+07 2.8480659178297508E+01 6.3698892627559292E+08 2.5616888212799370E+08 2.6246126258035838E+26 1.0380335043679656E+18 8.9721126112224137E-01 0.0000000000000000E+00 1.3734098733318145E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9519407306748097E-13 4.9747028870682308E-01 0.0000000000000000E+00 4.9834072756844394E-01 4.1738560219625794E-03 1.5126097041615202E-05 1.6047277265539146E-09 3.3477630291686892E-16 3.8281557620766546E-24 8.2724998243559635E-34 2.8267805744894221E-45 8.7811398111086553E-59 1.5215132151099706E-73 0.0000000000000000E+00 1.3508687111690902E-91 --- ---
- 115: 1.3606187983049275E+33 6.6035347647901282E+07 2.8890667446118275E+01 6.1339684272495782E+08 2.5073670444469622E+08 2.4944930722845564E+26 1.0225844931122472E+18 8.9797306206447003E-01 0.0000000000000000E+00 1.3734093734698162E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9382884538816835E-13 4.9747092526265896E-01 0.0000000000000000E+00 4.9834114654797773E-01 4.1728058230415324E-03 1.5120761688124827E-05 1.6036339840205146E-09 3.3444796371904733E-16 3.8230226784223969E-24 8.2581866635111093E-34 2.8205226357820794E-45 8.7563249834462831E-59 1.5162919093371422E-73 0.0000000000000000E+00 1.3454677242249796E-91 --- ---
- 116: 1.3932628286393314E+33 6.7029109495387167E+07 2.9299135869570023E+01 5.9052647559550560E+08 2.4540357821511984E+08 2.3699753652923032E+26 1.0072334100313551E+18 8.9873415639561538E-01 0.0000000000000000E+00 1.3734088793371717E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9273743905135341E-13 4.9747155452292613E-01 0.0000000000000000E+00 4.9834156072543678E-01 4.1717676603326079E-03 1.5115487752745162E-05 1.6025530490973807E-09 3.3412351979458230E-16 3.8179514465669260E-24 8.2440488100489724E-34 2.8143428824703951E-45 8.7318278099158464E-59 1.5111390220895722E-73 0.0000000000000000E+00 1.3401390353214052E-91 --- ---
- 117: 1.4255719360108027E+33 6.8021156160136253E+07 2.9705646090886727E+01 5.6838719912187672E+08 2.4017491253954741E+08 2.2509977221715514E+26 9.9199910455300314E+17 8.9949303907262013E-01 0.0000000000000000E+00 1.3734083916738578E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9185469127527003E-13 4.9747217554527123E-01 0.0000000000000000E+00 4.9834196948057147E-01 4.1707430885489886E-03 1.5110283124040479E-05 1.6014865304137264E-09 3.3380345201639231E-16 3.8129495453203476E-24 8.2301070013081029E-34 2.8082503174882158E-45 8.7076836712830850E-59 1.5060619310703925E-73 0.0000000000000000E+00 1.3348902110254984E-91 --- ---
- 118: 1.4574961913354622E+33 6.9010496302589059E+07 3.0109773688981306E+01 5.4698565423651242E+08 2.3505569613226926E+08 2.1374810287319089E+26 9.7690015290508454E+17 9.0024818358642278E-01 0.0000000000000000E+00 1.3734079112276337E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9112983848202610E-13 4.9747278737742739E-01 0.0000000000000000E+00 4.9834237218660810E-01 4.1697336787595062E-03 1.5105155772037507E-05 1.6004360520379742E-09 3.3348824560348159E-16 3.8080245160062871E-24 8.2163821328911811E-34 2.8022540043183388E-45 8.6839281458389451E-59 1.5010680467792364E-73 0.0000000000000000E+00 1.3297288434294859E-91 --- ---
- 119: 1.4889875365948238E+33 6.9996113916775107E+07 3.0511089116357429E+01 5.2632585036384499E+08 2.3005048830955136E+08 2.0293304345771733E+26 9.6195480112767552E+17 9.0099805277365441E-01 0.0000000000000000E+00 1.3734074387508590E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9052395590852765E-13 4.9747338906126470E-01 0.0000000000000000E+00 4.9834276821291462E-01 4.1687410117067338E-03 1.5100113714332170E-05 1.5994032465800824E-09 3.3317838806273887E-16 3.8031839305262123E-24 8.2028951703451791E-34 2.7963630287798104E-45 8.6605968599015294E-59 1.4961647814846525E-73 0.0000000000000000E+00 1.3246625184755657E-91 --- ---
- 120: 1.5199999999999995E+33 7.0976970084588349E+07 3.0909158791417685E+01 5.0640927968231225E+08 2.2516341274967867E+08 1.9264369674659486E+26 9.4718090818277734E+17 9.0174111034685933E-01 0.0000000000000000E+00 1.3734069749968960E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9000761033129498E-13 4.9747397963737516E-01 0.0000000000000000E+00 4.9834315692801889E-01 4.1677666702425150E-03 1.5095164977733582E-05 1.5983897473950685E-09 3.3287436686455383E-16 3.7984353553305971E-24 8.1896670496288505E-34 2.7905864560207221E-45 8.6377253198351694E-59 1.4913595144159852E-73 0.0000000000000000E+00 1.3196987804736782E-91 --- ---
- 121: 1.5504898944229376E+33 7.1952005152384058E+07 3.1303546345841873E+01 4.8723504214768881E+08 2.2039815399378172E+08 1.8286791483831781E+26 9.3259588930906778E+17 9.0247583299198642E-01 0.0000000000000000E+00 1.3734065207160409E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8955882102420930E-13 4.9747455815025099E-01 0.0000000000000000E+00 4.9834353770301637E-01 4.1668122307850644E-03 1.5090317554959184E-05 1.5973971797885434E-09 3.3257666682257312E-16 3.7937863108346474E-24 8.1767185650834307E-34 2.7849332821574578E-45 8.6153487233810733E-59 1.4866595527127962E-73 0.0000000000000000E+00 1.3148450923362913E-91 --- ---
- 122: 1.5804674455118365E+33 7.2921815957599625E+07 3.1694487897270928E+01 4.6878417599292821E+08 2.1575395066386375E+08 1.7358456042701018E+26 9.1820417672387251E+17 9.0320135185178030E-01 0.0000000000000000E+00 1.3734060762582377E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8916100592152667E-13 4.9747512415421913E-01 0.0000000000000000E+00 4.9834391024457464E-01 4.1658784286191181E-03 1.5085575165646095E-05 1.5964262932754887E-09 3.3228550988933474E-16 3.7892402090000219E-24 8.1640590580118943E-34 2.7794074975611020E-45 8.5934824275958735E-59 1.4820680307177908E-73 0.0000000000000000E+00 1.3101046024769671E-91 --- ---
- 123: 1.6099426589457796E+33 7.3886973462790087E+07 3.2082205997558859E+01 4.5102282608432353E+08 2.1122611870262653E+08 1.6476567537900128E+26 9.0399803152249382E+17 9.0391741972422968E-01 0.0000000000000000E+00 1.3734056416318907E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8880180692138674E-13 4.9747567763854861E-01 0.0000000000000000E+00 4.9834427454563840E-01 4.1649652814559840E-03 1.5080937885071900E-05 1.5954770912549492E-09 3.3200089426641059E-16 3.7847969682007983E-24 8.1516881413780210E-34 2.7740088464373221E-45 8.5721249881037958E-59 1.4775845551070575E-73 0.0000000000000000E+00 1.3054768175691438E-91 --- ---
- 124: 1.6389253255361677E+33 7.4848026164774343E+07 3.2466911041253873E+01 4.3391919946560413E+08 2.0681021103591594E+08 1.5638521390234437E+26 8.8997006262749773E+17 9.0462378146066813E-01 0.0000000000000000E+00 1.3734052168905469E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8847227972100009E-13 4.9747621853502000E-01 0.0000000000000000E+00 4.9834463056131373E-01 4.1640729018516034E-03 1.5076406270378958E-05 1.5945496759822339E-09 3.3172284785423091E-16 3.7804569715702995E-24 8.1396067255620719E-34 2.7687376410937669E-45 8.5512772177458046E-59 1.4732092084966967E-73 0.0000000000000000E+00 1.3009617376238040E-91 --- ---
- 125: 1.6674250262022876E+33 7.5805503179657608E+07 3.2848802514098352E+01 4.1744340176286811E+08 2.0250199852691329E+08 1.4841888234415196E+26 8.7611319455836378E+17 9.0532017476352844E-01 0.0000000000000000E+00 1.3734048021340406E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8816597851567928E-13 4.9747674671646680E-01 0.0000000000000000E+00 4.9834497820790791E-01 4.1632014996139475E-03 1.5071981372711087E-05 1.5936442509807990E-09 3.3145142895832054E-16 3.7762210777040449E-24 8.1278170471976619E-34 2.7635947740005767E-45 8.5309422316815819E-59 1.4689425583661472E-73 0.0000000000000000E+00 1.2965598646712511E-91 --- ---
- 126: 1.6954511368242891E+33 7.6759917055664867E+07 3.3228070106437322E+01 4.0156729008959031E+08 1.9829745281561866E+08 1.4084399541199508E+26 8.6242063826873754E+17 9.0600633093499294E-01 0.0000000000000000E+00 1.3734043975103750E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8787828451553321E-13 4.9747726199438302E-01 0.0000000000000000E+00 4.9834531736135484E-01 4.1623513857496882E-03 1.5067664757169871E-05 1.5927611250572632E-09 3.3118672747685853E-16 3.7720906388890407E-24 8.1163227190007196E-34 2.7585817390323980E-45 8.5111255289187084E-59 1.4647856736507895E-73 0.0000000000000000E+00 1.2922722193810121E-91 --- ---
- 127: 1.7230128329767566E+33 7.7711766358253568E+07 3.3604894709195655E+01 3.8626434041738838E+08 1.9419273080255267E+08 1.3363934679816810E+26 8.4888586461563610E+17 9.0668197558457386E-01 0.0000000000000000E+00 1.3734040032183694E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8760591570760945E-13 4.9747776411555167E-01 0.0000000000000000E+00 4.9834564785499591E-01 4.1615229780268079E-03 1.5063458530978404E-05 1.5919007179976736E-09 3.3092886659268783E-16 3.7680675272147652E-24 8.1051288015629275E-34 2.7537006623070266E-45 8.4918351118653123E-59 1.4607401493292984E-73 0.0000000000000000E+00 1.2881003659465033E-91 --- ---
- 128: 1.7501190945459738E+33 7.8661538065946102E+07 3.3979449308687741E+01 3.7150952767344272E+08 1.9018416057166630E+08 1.2678509247689830E+26 8.3550258008688666E+17 9.0734682930606259E-01 0.0000000000000000E+00 1.3734036195111264E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8734657044481802E-13 4.9747825275762048E-01 0.0000000000000000E+00 4.9834596947666826E-01 4.1607168082734795E-03 1.5059365380462068E-05 1.5910635680686229E-09 3.3067800500655972E-16 3.7641541691349109E-24 8.0942418986785006E-34 2.7489543432968419E-45 8.4730816465389466E-59 1.4568081395496522E-73 0.0000000000000000E+00 1.2840464457873208E-91 --- ---
- 129: 1.7767787102338976E+33 7.9609709810465902E+07 3.4351899793134386E+01 3.5727921707148361E+08 1.8626822857392487E+08 1.2026264518779903E+26 8.2226470450022451E+17 9.0800060833070539E-01 0.0000000000000000E+00 1.3734032467005774E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8709866949897483E-13 4.9747872752332778E-01 0.0000000000000000E+00 4.9834628196490399E-01 4.1599335319049656E-03 1.5055388619341931E-05 1.5902503418326164E-09 3.3043433986402773E-16 3.7603535908529976E-24 8.0836702827928802E-34 2.7443463090781598E-45 8.4548786747159529E-59 1.4529924016521561E-73 0.0000000000000000E+00 1.2801132224932901E-91 --- ---
- 130: 1.8030002819517733E+33 8.0556751990866557E+07 3.4722405681313681E+01 3.4355106538984966E+08 1.8244156792320818E+08 1.1405457882321872E+26 8.0916635036895219E+17 9.0864302516462958E-01 0.0000000000000000E+00 1.3734028851631852E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8686117031331922E-13 4.9747918793322721E-01 0.0000000000000000E+00 4.9834658500414197E-01 4.1591739399259916E-03 1.5051532249595689E-05 1.5894618465332147E-09 3.3019811045228952E-16 3.7566694757170045E-24 8.0734240538551654E-34 2.7398808831409704E-45 8.4372428836004937E-59 1.4492963522506773E-73 0.0000000000000000E+00 1.2763041391991355E-91 --- ---
- 131: 1.8287922291062446E+33 8.1503129788252994E+07 3.5091120785688361E+01 3.3030393108304876E+08 1.7870094767464796E+08 1.0814454160894171E+26 7.9620180371139789E+17 9.0927378921772672E-01 0.0000000000000000E+00 1.3734025353471473E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8663343426122275E-13 4.9747963341652057E-01 0.0000000000000000E+00 4.9834687821869372E-01 4.1584389740554383E-03 1.5047801038168847E-05 1.5886990457201322E-09 3.2996960286752654E-16 3.7531062367462023E-24 8.0635153402471175E-34 2.7355632725315446E-45 8.4201944478762354E-59 1.4457241384794955E-73 0.0000000000000000E+00 1.2726233915849097E-91 --- ---
- 132: 1.8541627927807330E+33 8.2449305105278909E+07 3.5458193814915063E+01 3.1751779226122850E+08 1.7504326297676697E+08 1.0251717711397060E+26 7.8336550609502669E+17 9.0989260743115086E-01 0.0000000000000000E+00 1.3734021977814688E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8641513294844956E-13 4.9748006329950351E-01 0.0000000000000000E+00 4.9834716116513883E-01 4.1577297457880422E-03 1.5044200613670787E-05 1.5879630789584541E-09 3.2974915590536308E-16 3.7496691082245590E-24 8.0539585527148928E-34 2.7313996780809056E-45 8.4037574628688459E-59 1.4422807283217247E-73 0.0000000000000000E+00 1.2690760205291579E-91 --- ---
- 133: 1.8791200398147914E+33 8.3395738452777207E+07 3.5823768925751992E+01 3.0517367169515985E+08 1.7146552600689328E+08 9.7158052248351642E+25 7.7065203769857510E+17 9.1049918491241078E-01 0.0000000000000000E+00 1.3734018730874022E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8620618349962926E-13 4.9748047679099416E-01 0.0000000000000000E+00 4.9834743332273412E-01 4.1570475604354590E-03 1.5040737588345686E-05 1.5872552867021360E-09 3.2953716849771463E-16 3.7463642613958089E-24 8.0447707052878565E-34 2.7273974338033104E-45 8.3879604927962899E-59 1.4389720250335784E-73 0.0000000000000000E+00 1.2656680295720382E-91 --- ---
- 134: 1.9036718667840526E+33 8.4342890804562554E+07 3.6187986227976246E+01 2.9325356811179924E+08 1.6796485761849791E+08 9.2053591514272751E+25 7.5805610125639334E+17 9.1109322558603945E-01 0.0000000000000000E+00 1.3734015619930544E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8600670577844856E-13 4.9748087296373333E-01 0.0000000000000000E+00 4.9834769408117141E-01 4.1563939478118910E-03 1.5037419713769948E-05 1.5865772420579183E-09 3.2933410921272147E-16 3.7431989523098829E-24 8.0359718255471451E-34 2.7235651851970409E-45 8.3728372724764534E-59 1.4358050136918353E-73 0.0000000000000000E+00 1.2624065354477412E-91 --- ---
- 135: 1.9278260038833399E+33 8.5291225440593407E+07 3.6550982248759425E+01 2.8174039313524628E+08 1.6453847964733407E+08 8.7191016865707948E+25 7.4557250668909171E+17 9.1167443287216954E-01 0.0000000000000000E+00 1.3734012653522857E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8581699676866702E-13 4.9748125073031724E-01 0.0000000000000000E+00 4.9834794272473643E-01 4.1557707019411827E-03 1.5034256082340011E-05 1.5859307919035921E-09 3.2914052855532492E-16 3.7401817133114416E-24 8.0275854861667757E-34 2.7199131203408359E-45 8.3584276172682438E-59 1.4327879513247713E-73 0.0000000000000000E+00 1.2592999634780869E-91 --- ---
- 136: 1.9515900187154163E+33 8.6241209798256621E+07 3.6912890361212128E+01 2.7061791330622196E+08 1.6118370785497007E+08 8.2558292609850121E+25 7.3319615629996659E+17 9.1224251040740423E-01 0.0000000000000000E+00 1.3734009841695817E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8563751919653880E-13 4.9748160881152204E-01 0.0000000000000000E+00 4.9834817841146045E-01 4.1551799333150305E-03 1.5031257392465019E-05 1.5853181110195519E-09 3.2895707516377034E-16 3.7373226052347512E-24 8.0196395051350653E-34 2.7164532744190790E-45 8.3447786225976263E-59 1.4299306176474896E-73 0.0000000000000000E+00 1.2563583053413569E-91 --- ---
- 137: 1.9749713199878009E+33 8.7193317351525128E+07 3.7273841178500916E+01 2.5987069668012807E+08 1.5789794552434534E+08 7.8144074850590258E+25 7.2092203038852224E+17 9.1279716282984935E-01 0.0000000000000000E+00 1.3734007196336549E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8546890325424385E-13 4.9748194569351212E-01 0.0000000000000000E+00 4.9834840014495524E-01 4.1546241394922840E-03 1.5028436306851290E-05 1.5847417752358732E-09 3.2878451769881490E-16 3.7346335582989027E-24 8.0121668924309444E-34 2.7131999415264741E-45 8.3319462865394789E-59 1.4272446543285639E-73 0.0000000000000000E+00 1.2535934679535259E-91 --- ---
- 138: 1.9979771611200066E+33 8.8148029538134888E+07 3.7633962919974358E+01 2.4948406356114507E+08 1.5467867779529452E+08 7.3937665032153574E+25 7.0874517313931866E+17 9.1333809666116961E-01 0.0000000000000000E+00 1.3734004731642083E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8531196214263444E-13 4.9748225956828834E-01 0.0000000000000000E+00 4.9834860673521625E-01 4.1541063033478168E-03 1.5025807951123220E-05 1.5842048632443050E-09 3.2862377531412926E-16 3.7321288467051647E-24 8.0052071681785233E-34 2.7101702481656930E-45 8.3199977699945825E-59 1.4247440376755425E-73 0.0000000000000000E+00 1.2510197596500463E-91 --- ---
- 139: 2.0206146437634887E+33 8.9105837755739763E+07 3.7993381749412713E+01 2.3944404097987667E+08 1.5152346696075791E+08 6.9928967191422824E+25 6.9666067867435494E+17 9.1386502134313752E-01 0.0000000000000000E+00 1.3734002464798630E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8516772499873563E-13 4.9748254824718507E-01 0.0000000000000000E+00 4.9834879674168708E-01 4.1536300357872908E-03 1.5023390638130250E-05 1.5837111045069434E-09 3.2847596192593936E-16 3.7298257782309912E-24 7.9988082781280207E-34 2.7073849867314639E-45 8.3090146820015279E-59 1.4224457658217088E-73 0.0000000000000000E+00 1.2486545970984261E-91 --- ---
- 140: 2.0428907212365411E+33 9.0067245449261516E+07 3.8352222087114974E+01 2.2973732056434730E+08 1.4842994924132973E+08 6.6108448571115363E+25 6.8466367712783642E+17 9.1437765053672904E-01 0.0000000000000000E+00 1.3734000417022340E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8503749562679605E-13 4.9748280902832687E-01 0.0000000000000000E+00 4.9834896838602050E-01 4.1531997944185758E-03 1.5021206977766934E-05 1.5832651059033795E-09 3.2834245405266308E-16 3.7277457510389667E-24 7.9930295293326744E-34 2.7048698930139979E-45 8.2990981157262635E-59 1.4203709122064038E-73 0.0000000000000000E+00 1.2465195891213508E-91 --- ---
- 141: 2.0648122018763024E+33 9.1032770313400701E+07 3.8710606901698881E+01 2.2035121949003994E+08 1.4539583428392470E+08 6.2467103284288711E+25 6.7274932062391091E+17 9.1487570391831075E-01 0.0000000000000000E+00 1.3733998615277979E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8492295632577719E-13 4.9748303847776126E-01 0.0000000000000000E+00 4.9834911940802146E-01 4.1528212446438513E-03 1.5019285709631721E-05 1.5828727260067592E-09 3.2822500284519382E-16 3.7259159989396810E-24 7.9879464384107718E-34 2.7026577560744977E-45 8.2903769661213112E-59 1.4185463656356783E-73 0.0000000000000000E+00 1.2446423269601157E-91 --- ---
- 142: 2.0863857523099949E+33 9.2002946636597291E+07 3.9068657980401461E+01 2.1127364422041491E+08 1.4241891076666349E+08 5.8996418753917274E+25 6.6091276903555328E+17 9.1535891006851822E-01 0.0000000000000000E+00 1.3733997095437626E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8482636464003325E-13 4.9748323202720035E-01 0.0000000000000000E+00 4.9834924680088355E-01 4.1525019233121874E-03 1.5017665071276201E-05 1.5825417629673783E-09 3.2812593998810744E-16 3.7243727990281117E-24 7.9836596422368077E-34 2.7007922960289607E-45 8.2830232171962371E-59 1.4170080284079263E-73 0.0000000000000000E+00 1.2430596746880489E-91 --- ---
- 143: 2.1076179006474449E+33 9.2978327815808505E+07 3.9426496188160826E+01 2.0249305675219533E+08 1.3949706947616950E+08 5.5688344680727273E+25 6.4914917546131123E+17 9.1582701238590958E-01 0.0000000000000000E+00 1.3733995909142193E+01 5.0000000000000000E-01 convective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8475098631484929E-13 4.9748338310021822E-01 0.0000000000000000E+00 4.9834934623605837E-01 4.1522526803341921E-03 1.5016400114811878E-05 1.5822834487182991E-09 3.2804862494606265E-16 3.7231684389787553E-24 7.9803142524036689E-34 2.6993365865636912E-45 8.2772851447604146E-59 1.4158077621682041E-73 0.0000000000000000E+00 1.2418249152894769E-91 --- ---
- 144: 2.1285150395968905E+33 9.3959489076110289E+07 3.9784241748720717E+01 1.9399844294999138E+08 1.3662840139848822E+08 5.2535264318215056E+25 6.3745367160961254E+17 9.1627978759369422E-01 0.0000000000000000E+00 1.3733995144077191E+01 5.0000000000000000E-01 semiconvective APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.8470238094365034E-13 4.9748348053016389E-01 0.0000000000000000E+00 4.9834941036374397E-01 4.1520919386571157E-03 1.5015584327260539E-05 1.5821168641275845E-09 3.2799876646880860E-16 3.7223918029568684E-24 7.9781570386174700E-34 2.6983979383257838E-45 8.2735854043097881E-59 1.4150339061994714E-73 0.0000000000000000E+00 1.2410288592484852E-91 --- ---
- 145: 2.1490834295060223E+33 9.4947037710775256E+07 4.0128507603072393E+01 1.8577789951173943E+08 1.3338449954180281E+08 4.9529967856574731E+25 6.2582957536385830E+17 9.1749669595411909E-01 0.0000000000000000E+00 1.3714285714559658E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3681227648033488E-20 4.9999999996497202E-01 0.0000000000000000E+00 4.9999999997702554E-01 5.7794005203834719E-11 2.0846463058007317E-13 2.1780317586606001E-17 4.4806251518088832E-24 5.0375639852250868E-32 1.0687310837592159E-41 3.5687515811398333E-53 1.0764278438490333E-66 1.8109873553132690E-81 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 146: 2.1693292013301543E+33 9.5941632350789160E+07 4.0473278179001142E+01 1.7781734290896434E+08 1.3265414984484027E+08 4.6665628616613118E+25 6.1426793534261594E+17 9.1827811809348781E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.4641347123264814E-25 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 7.4771795405456770E-25 5.5675336723089059E-59 3.6629887452922753E-54 4.9709365719861298E-55 1.1400308799652607E-92 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 147: 2.1892583595293722E+33 9.6943932717679545E+07 4.0818683197352854E+01 1.7011312721605346E+08 1.3192624810081083E+08 4.3935782586814924E+25 6.0275924720525914E+17 9.1908499423892043E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 8.9802595901625679E-26 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 4.5678356432806741E-25 1.4171780296234324E-59 1.6953179932132129E-54 2.3080089889406893E-55 2.1764704497166064E-93 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 148: 2.2088767848964524E+33 9.7954634143736809E+07 4.1164854131071664E+01 1.6265604611978179E+08 1.3120053664681038E+08 4.1334303084121219E+25 5.9129841316758720E+17 9.1991957587647943E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.4867698311465907E-26 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.7817685474328872E-25 3.6090466102654571E-60 7.8092806454658969E-55 1.0667375140745898E-55 4.1099372748991188E-94 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 149: 2.2281902373173027E+33 9.8974471986514300E+07 4.1511924457388488E+01 1.5543729022876465E+08 1.3047674721821432E+08 3.8855381043517474E+25 5.7988022201826010E+17 9.2078429604463607E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.3389478166380977E-26 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.6883312759259762E-25 9.1883767884940086E-61 3.5788552995673128E-55 4.9060603370612642E-56 7.6574982989161151E-95 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 150: 2.2472043584656280E+33 1.0000422657800213E+08 4.1860029879143674E+01 1.4844842620863861E+08 1.2975459682031882E+08 3.6493506675344080E+25 5.6849932633713459E+17 9.2168179037692954E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.0234600344610445E-26 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 1.0209411613315936E-25 2.3362997092316744E-61 1.6310494594921473E-55 2.2443265600395146E-56 1.3567520997863097E-95 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 151: 2.2659246744334769E+33 1.0104472880252595E+08 4.2209308517186990E+01 1.4168137717283028E+08 1.2903378565491158E+08 3.4243452384836486E+25 5.5715021741097440E+17 9.2261492163841929E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2209040945509507E-26 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 6.1492382201335091E-26 5.9255855697940053E-62 7.3889510089743507E-56 1.0207664114974231E-56 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 152: 2.2843565982992821E+33 1.0209686641578907E+08 4.2559901064472811E+01 1.3512840423557171E+08 1.2831399349886946E+08 3.2100256858706261E+25 5.4582719738674464E+17 9.2358680757471823E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 7.3326852209973273E-27 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 3.6879099657626097E-26 1.4970424304003952E-62 3.3256612802489430E-56 4.6136846517125419E-57 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 153: 2.3025054326349690E+33 1.0316159124041480E+08 4.2911950889630518E+01 1.2878208912276076E+08 1.2759487656675032E+08 3.0059210232655138E+25 5.3452434815473837E+17 9.2460085324993024E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3824240735506905E-27 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.2015410902396634E-26 3.7614602410990136E-63 1.4863521601025378E-56 2.0712256188809010E-57 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 154: 2.3203763719536581E+33 1.0423992740191777E+08 4.3265604068911131E+01 1.2263531775135146E+08 1.2687606399410895E+08 2.8115840262049596E+25 5.2323549633248032E+17 9.2566078855822920E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6055115103583454E-27 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3076653364279536E-26 9.3834728535200296E-64 6.5926866479930693E-57 9.2304322278072457E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 155: 2.3379745050994525E+33 1.0533298080507185E+08 4.3621009326468418E+01 1.1668126467544584E+08 1.2615715937934820E+08 2.6265899425581478E+25 5.1195417363117747E+17 9.2677071397344457E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.5404161110930331E-27 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 7.7252277759396693E-27 2.3199537146121333E-64 2.9001923648870623E-57 4.0810127490384539E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 156: 2.3553048175807600E+33 1.0644195008155930E+08 4.3978317844284184E+01 1.1091337978402086E+08 1.2543716721256247E+08 2.4505352898774815E+25 5.0067356797164730E+17 9.2793493067462196E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.0508564739841877E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 4.5362435904111378E-27 5.6713043983838229E-65 1.2641143574370103E-57 1.7883239799155431E-58 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 157: 2.3723721938485611E+33 1.0756813933145609E+08 4.4337682901112672E+01 1.0532537333570339E+08 1.2471477854007621E+08 2.2830367339837928E+25 4.8938647335053651E+17 9.2915805532444529E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.2810856093604713E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.6455454461847931E-27 1.3671424841755632E-65 5.4527194078411623E-58 7.7578037269962127E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 158: 2.3891814195209998E+33 1.0871297305041879E+08 4.4699259278221938E+01 9.9911200561468959E+07 1.2398916453350425E+08 2.1237300438109430E+25 4.7808523494893357E+17 9.3044540501182504E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0581498527131185E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.5313634918331919E-27 3.2423669830272448E-66 2.3251887451501512E-58 3.3281947429309080E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 159: 2.4057371835556315E+33 1.0987801368781400E+08 4.5063202346238697E+01 9.4665049820228726E+07 1.2325962172166878E+08 1.9722691181873140E+25 4.6676167712684262E+17 9.3180298130111117E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7563547495856088E-28 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 8.7921183467088954E-28 7.5480996376601333E-67 9.7919930151743017E-59 1.4106498118750436E-59 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 160: 2.4220440803706373E+33 1.1106498243632422E+08 4.5429666716430447E+01 8.9581330742348090E+07 1.2252535289744382E+08 1.8283250806257244E+25 4.5540702029855194E+17 9.3323748990946076E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.9968255508585630E-29 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 5.0030278482287127E-28 1.7206057755640133E-67 4.0676676566416114E-59 5.9003675188481645E-60 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 161: 2.4381066119162685E+33 1.1227578402063718E+08 4.5798804297823715E+01 8.4654662227338329E+07 1.2178543648179320E+08 1.6915854388058627E+25 4.4401178432047194E+17 9.3475644778009048E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.6343177574640044E-29 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.8191885320086461E-28 3.8304035120776928E-68 1.6645847717263427E-59 2.4323705247782598E-60 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 162: 2.4539291896977627E+33 1.1351253646762478E+08 4.6170761531336893E+01 7.9879860674499825E+07 1.2103879729526904E+08 1.5617533060793596E+25 4.3256567370951558E+17 9.3636831475986548E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.1414374753217560E-29 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 1.5715974162895170E-28 8.3035376231317581E-69 6.7002910195088952E-60 9.8680468150504537E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 163: 2.4695161367509312E+33 1.1477760713543463E+08 4.6545675486275393E+01 7.5251928335402220E+07 1.2028417060749592E+08 1.4385466829720773E+25 4.2105744014300454E+17 9.3808265297626869E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.7307577175538728E-29 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 8.6575270796383284E-29 1.7471372207822152E-69 2.6481872731529370E-60 3.9331853273986397E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 164: 2.4848716895715934E+33 1.1607365668091825E+08 4.6923668362044957E+01 7.0766041635272801E+07 1.1952005695390435E+08 1.3216977973810357E+25 4.0947471636656397E+17 9.3991032108318862E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 9.4101835480528014E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 4.7066520479241831E-29 3.5550052970069652E-70 1.0256219861346084E-60 1.5371247538310528E-61 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 165: 2.4999999999999987E+33 1.1740369319944501E+08 4.7304839742853567E+01 6.6417539274621010E+07 1.1874466334089839E+08 1.2109525029898308E+25 3.9780381376506605E+17 9.4186371217742604E-01 0.0000000000000000E+00 1.3714285714285740E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0413761941991752E-30 4.9999999999995770E-01 0.0000000000000000E+00 4.9999999999997180E-01 2.5213254556580110E-29 6.9658070869986210E-71 3.8830528177009015E-61 5.8764538354347440E-62 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 166: 2.5149051370613488E+33 1.1877113954737934E+08 4.7689255645677989E+01 6.2201909865239829E+07 1.1795582687313065E+08 1.1060697364211095E+25 3.8602947327987603E+17 9.4395704816026138E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.6564578569888753E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3284830919389867E-29 1.3079455296213149E-71 1.4331126599591723E-61 2.1916249962960820E-62 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 167: 2.5299552941601440E+33 1.2021568845534894E+08 4.8086661165681640E+01 5.8063831582821235E+07 1.1714046902788302E+08 1.0055994876395487E+25 3.7398308279902656E+17 9.4623622144715291E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.3621162793068500E-30 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 6.8115557592677662E-30 2.2882896725637709E-72 5.0708071806153807E-62 7.8438234294930733E-63 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 168: 2.5455295344943751E+33 1.2178609224376135E+08 4.8507960646257800E+01 5.3901697945172668E+07 1.1627263050001456E+08 9.0714811357468677E+24 3.6132195411732422E+17 9.4879373751034390E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.6508189161844866E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 3.3257575512578545E-30 3.5248990644712356E-73 1.6631478822278938E-62 2.6059458163526254E-63 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 169: 2.5620467932126522E+33 1.2354671756411198E+08 4.8966104146224986E+01 4.9613793424682647E+07 1.1531920841890560E+08 8.0859659131021962E+24 3.4763540875597165E+17 9.5176110020507543E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 3.0066759368152095E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.5034492727455624E-30 4.4427168220917690E-74 4.8402929795842299E-63 7.6982003282846239E-64 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 170: 2.5799999999999987E+33 1.2558855757696001E+08 4.9477156772938500E+01 4.5091042786710382E+07 1.1423409284461752E+08 7.0799720427888998E+24 3.3239296535890995E+17 9.5533652543871506E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.2098233893926677E-31 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 6.0494179489150235E-31 4.1336862884631123E-75 1.1756055233235625E-63 1.9036114627221858E-64 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 171: 2.5999999999999986E+33 1.2804956162083213E+08 5.0061394114705344E+01 4.0209170958311252E+07 1.1294690472865297E+08 6.0353627930080527E+24 3.1485902678856307E+17 9.5983857651815008E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.0801210760294860E-32 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.0401236906938037E-31 2.4274210629244725E-76 2.1700243183215155E-64 3.5937729671644964E-65 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 172: 2.6199999999999985E+33 1.3075086071959628E+08 5.0658027507872603E+01 3.5185337114629045E+07 1.1145575996701628E+08 5.0087493908160733E+24 2.9541617782861651E+17 9.6537403967188118E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 1.1517889398084661E-32 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 5.7590473330452164E-32 8.9677477115207630E-78 3.0370407574189627E-65 5.1691427046015130E-66 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 173: 2.6399999999999984E+33 1.3375633503767094E+08 5.1259029202265040E+01 3.0274252542360757E+07 1.0976511447512566E+08 4.0571174047154991E+24 2.7472664944937638E+17 9.7196742389115642E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 2.7463876243969741E-33 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 1.3732069134562683E-32 2.1353439031076443E-79 3.2655672820039067E-66 5.7385614174413676E-67 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 174: 2.6599999999999983E+33 1.3716145781802258E+08 5.1846090157430211E+01 2.5471200855979081E+07 1.0777544311604048E+08 3.1815442236151246E+24 2.5246025639233558E+17 9.7997593900150348E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.1359589679990117E-34 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.5679913133323683E-33 2.7039200919748929E-81 2.3995791484228709E-67 4.3781884115675908E-68 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 175: 2.6799999999999983E+33 1.4111957716106588E+08 5.2375797432508648E+01 2.0768002746000260E+07 1.0530364206242168E+08 2.3837346696068625E+24 2.2811343677418570E+17 9.8995229930731898E-01 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 6.5800061611629815E-35 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 3.2900093272030120E-34 1.2832722924045429E-83 9.7272282763209480E-69 1.8552963282834060E-69 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 176: 2.6999999999999982E+33 1.4590424036682683E+08 5.2733478434499197E+01 1.6149260898153769E+07 1.0197244273753545E+08 1.6663836934043726E+24 2.0084765744387616E+17 1.0028126189404210E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 4.3638405544813781E-36 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 2.1819215802324812E-35 1.1068424778679198E-86 1.3936430952548892E-70 2.8004295714509804E-71 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 177: 2.7199999999999981E+33 1.5209308329161724E+08 5.2544288210768478E+01 1.1581998402262446E+07 9.6860068989120141E+07 1.0339163961380312E+24 1.6906113594201485E+17 1.0202256938504008E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
- 178: 2.7399999999999980E+33 1.6137701720888814E+08 4.9864788058154794E+01 6.9763598642695881E+06 8.6745657673518360E+07 4.9431009391835863E+23 1.2881425018238709E+17 1.0453144799781566E+00 0.0000000000000000E+00 1.3714285714285715E+01 5.0000000000000000E-01 radiative APPROX 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 5.0000000000000000E-01 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 0.0000000000000000E+00 --- ---
diff --git a/Util/initial_models/kepler_hybrid/model_6.e8.raw b/Util/initial_models/kepler_hybrid/model_6.e8.raw
deleted file mode 100644
index cbe6988ea..000000000
--- a/Util/initial_models/kepler_hybrid/model_6.e8.raw
+++ /dev/null
@@ -1,186 +0,0 @@
-# npts = 178
-# num of variables = 6
-# density
-# temperature
-# pressure
-# carbon-12
-# oxygen-16
-# magnesium-24
-2.075E+06 2.674E+09 5.999E+08 1.802E+27 4.974E-01 4.983E-01 0.00425948
-2.798E+06 2.670E+09 5.994E+08 1.798E+27 4.974E-01 4.983E-01 0.00425948
-3.410E+06 2.666E+09 5.988E+08 1.795E+27 4.974E-01 4.983E-01 0.00425948
-3.965E+06 2.661E+09 5.982E+08 1.791E+27 4.974E-01 4.983E-01 0.00425948
-4.475E+06 2.657E+09 5.976E+08 1.787E+27 4.974E-01 4.983E-01 0.00425948
-4.939E+06 2.652E+09 5.970E+08 1.782E+27 4.974E-01 4.983E-01 0.00425947
-5.373E+06 2.647E+09 5.963E+08 1.778E+27 4.974E-01 4.983E-01 0.00425847
-5.784E+06 2.642E+09 5.956E+08 1.774E+27 4.974E-01 4.983E-01 0.00425847
-6.179E+06 2.637E+09 5.949E+08 1.769E+27 4.974E-01 4.983E-01 0.00425847
-6.559E+06 2.632E+09 5.942E+08 1.764E+27 4.974E-01 4.983E-01 0.00425847
-6.927E+06 2.627E+09 5.935E+08 1.760E+27 4.974E-01 4.983E-01 0.00425847
-7.283E+06 2.621E+09 5.928E+08 1.755E+27 4.974E-01 4.983E-01 0.00425847
-7.628E+06 2.616E+09 5.920E+08 1.750E+27 4.974E-01 4.983E-01 0.00425747
-7.961E+06 2.610E+09 5.913E+08 1.745E+27 4.974E-01 4.983E-01 0.00425747
-8.282E+06 2.605E+09 5.905E+08 1.740E+27 4.974E-01 4.983E-01 0.00425747
-8.591E+06 2.599E+09 5.897E+08 1.735E+27 4.974E-01 4.983E-01 0.00425747
-8.888E+06 2.593E+09 5.890E+08 1.730E+27 4.974E-01 4.983E-01 0.00425747
-9.173E+06 2.588E+09 5.882E+08 1.725E+27 4.974E-01 4.983E-01 0.00425646
-9.444E+06 2.583E+09 5.875E+08 1.720E+27 4.974E-01 4.983E-01 0.00425646
-9.701E+06 2.577E+09 5.868E+08 1.715E+27 4.974E-01 4.983E-01 0.00425646
-9.944E+06 2.572E+09 5.861E+08 1.711E+27 4.974E-01 4.983E-01 0.00425646
-1.018E+07 2.567E+09 5.854E+08 1.706E+27 4.974E-01 4.983E-01 0.00425546
-1.041E+07 2.562E+09 5.847E+08 1.702E+27 4.974E-01 4.983E-01 0.00425546
-1.064E+07 2.557E+09 5.840E+08 1.698E+27 4.974E-01 4.983E-01 0.00425546
-1.088E+07 2.552E+09 5.833E+08 1.693E+27 4.974E-01 4.983E-01 0.00425546
-1.112E+07 2.547E+09 5.825E+08 1.688E+27 4.974E-01 4.983E-01 0.00425546
-1.138E+07 2.541E+09 5.817E+08 1.683E+27 4.974E-01 4.983E-01 0.00425446
-1.165E+07 2.534E+09 5.808E+08 1.677E+27 4.974E-01 4.983E-01 0.00425445
-1.195E+07 2.528E+09 5.799E+08 1.671E+27 4.974E-01 4.983E-01 0.00425445
-1.228E+07 2.520E+09 5.788E+08 1.664E+27 4.974E-01 4.983E-01 0.00425445
-1.264E+07 2.511E+09 5.776E+08 1.657E+27 4.974E-01 4.983E-01 0.00425345
-1.305E+07 2.501E+09 5.762E+08 1.648E+27 4.974E-01 4.983E-01 0.00425345
-1.348E+07 2.490E+09 5.747E+08 1.638E+27 4.974E-01 4.983E-01 0.00425245
-1.395E+07 2.478E+09 5.729E+08 1.627E+27 4.974E-01 4.983E-01 0.00425244
-1.445E+07 2.464E+09 5.710E+08 1.615E+27 4.974E-01 4.983E-01 0.00425144
-1.498E+07 2.449E+09 5.690E+08 1.602E+27 4.974E-01 4.983E-01 0.00425144
-1.553E+07 2.433E+09 5.667E+08 1.588E+27 4.974E-01 4.983E-01 0.00425043
-1.610E+07 2.416E+09 5.643E+08 1.573E+27 4.974E-01 4.983E-01 0.00424943
-1.668E+07 2.398E+09 5.618E+08 1.558E+27 4.974E-01 4.983E-01 0.00424943
-1.728E+07 2.379E+09 5.591E+08 1.541E+27 4.974E-01 4.983E-01 0.00424842
-1.788E+07 2.360E+09 5.563E+08 1.524E+27 4.974E-01 4.983E-01 0.00424742
-1.848E+07 2.340E+09 5.534E+08 1.507E+27 4.974E-01 4.983E-01 0.00424642
-1.909E+07 2.319E+09 5.505E+08 1.489E+27 4.974E-01 4.983E-01 0.00424541
-1.969E+07 2.298E+09 5.474E+08 1.471E+27 4.974E-01 4.983E-01 0.00424541
-2.028E+07 2.276E+09 5.444E+08 1.452E+27 4.974E-01 4.983E-01 0.0042444
-2.085E+07 2.255E+09 5.413E+08 1.434E+27 4.974E-01 4.983E-01 0.0042434
-2.142E+07 2.234E+09 5.382E+08 1.416E+27 4.974E-01 4.983E-01 0.0042424
-2.196E+07 2.213E+09 5.352E+08 1.399E+27 4.974E-01 4.983E-01 0.00424139
-2.249E+07 2.193E+09 5.322E+08 1.381E+27 4.974E-01 4.983E-01 0.00424139
-2.299E+07 2.173E+09 5.293E+08 1.365E+27 4.974E-01 4.983E-01 0.00424039
-2.347E+07 2.154E+09 5.265E+08 1.349E+27 4.974E-01 4.983E-01 0.00423938
-2.393E+07 2.135E+09 5.238E+08 1.333E+27 4.974E-01 4.983E-01 0.00423938
-2.437E+07 2.118E+09 5.211E+08 1.318E+27 4.974E-01 4.983E-01 0.00423838
-2.479E+07 2.100E+09 5.186E+08 1.304E+27 4.974E-01 4.983E-01 0.00423837
-2.521E+07 2.084E+09 5.160E+08 1.290E+27 4.974E-01 4.983E-01 0.00423737
-2.561E+07 2.067E+09 5.136E+08 1.276E+27 4.974E-01 4.983E-01 0.00423637
-2.600E+07 2.051E+09 5.111E+08 1.263E+27 4.974E-01 4.983E-01 0.00423637
-2.639E+07 2.035E+09 5.087E+08 1.250E+27 4.974E-01 4.983E-01 0.00423536
-2.677E+07 2.019E+09 5.063E+08 1.237E+27 4.974E-01 4.983E-01 0.00423536
-2.715E+07 2.003E+09 5.040E+08 1.224E+27 4.974E-01 4.983E-01 0.00423436
-2.753E+07 1.988E+09 5.016E+08 1.211E+27 4.974E-01 4.983E-01 0.00423435
-2.790E+07 1.972E+09 4.992E+08 1.198E+27 4.974E-01 4.983E-01 0.00423335
-2.828E+07 1.956E+09 4.968E+08 1.185E+27 4.974E-01 4.983E-01 0.00423335
-2.866E+07 1.940E+09 4.944E+08 1.172E+27 4.974E-01 4.983E-01 0.00423235
-2.904E+07 1.924E+09 4.919E+08 1.159E+27 4.974E-01 4.983E-01 0.00423234
-2.942E+07 1.908E+09 4.894E+08 1.146E+27 4.974E-01 4.983E-01 0.00423134
-2.981E+07 1.892E+09 4.869E+08 1.133E+27 4.974E-01 4.983E-01 0.00423134
-3.021E+07 1.875E+09 4.843E+08 1.120E+27 4.974E-01 4.983E-01 0.00423034
-3.061E+07 1.858E+09 4.816E+08 1.106E+27 4.974E-01 4.983E-01 0.00423033
-3.103E+07 1.840E+09 4.789E+08 1.092E+27 4.974E-01 4.983E-01 0.00422933
-3.145E+07 1.823E+09 4.761E+08 1.078E+27 4.974E-01 4.983E-01 0.00422933
-3.189E+07 1.804E+09 4.731E+08 1.063E+27 4.974E-01 4.983E-01 0.00422833
-3.235E+07 1.785E+09 4.701E+08 1.048E+27 4.974E-01 4.983E-01 0.00422832
-3.282E+07 1.765E+09 4.670E+08 1.033E+27 4.974E-01 4.983E-01 0.00422732
-3.331E+07 1.745E+09 4.637E+08 1.017E+27 4.974E-01 4.983E-01 0.00422632
-3.382E+07 1.723E+09 4.603E+08 1.000E+27 4.974E-01 4.983E-01 0.00422631
-3.435E+07 1.701E+09 4.567E+08 9.828E+26 4.974E-01 4.983E-01 0.00422531
-3.490E+07 1.678E+09 4.530E+08 9.649E+26 4.974E-01 4.983E-01 0.00422431
-3.547E+07 1.654E+09 4.491E+08 9.465E+26 4.974E-01 4.983E-01 0.0042243
-3.606E+07 1.629E+09 4.450E+08 9.276E+26 4.974E-01 4.983E-01 0.0042233
-3.667E+07 1.604E+09 4.408E+08 9.082E+26 4.975E-01 4.983E-01 0.00422229
-3.730E+07 1.578E+09 4.365E+08 8.883E+26 4.975E-01 4.983E-01 0.00422129
-3.795E+07 1.551E+09 4.320E+08 8.680E+26 4.975E-01 4.983E-01 0.00422029
-3.862E+07 1.523E+09 4.274E+08 8.473E+26 4.975E-01 4.983E-01 0.00422028
-3.930E+07 1.495E+09 4.226E+08 8.263E+26 4.975E-01 4.983E-01 0.00421928
-4.001E+07 1.466E+09 4.177E+08 8.050E+26 4.975E-01 4.983E-01 0.00421827
-4.073E+07 1.437E+09 4.127E+08 7.834E+26 4.975E-01 4.983E-01 0.00421727
-4.147E+07 1.407E+09 4.075E+08 7.616E+26 4.975E-01 4.983E-01 0.00421626
-4.223E+07 1.377E+09 4.022E+08 7.397E+26 4.975E-01 4.983E-01 0.00421526
-4.300E+07 1.346E+09 3.969E+08 7.177E+26 4.975E-01 4.983E-01 0.00421426
-4.379E+07 1.315E+09 3.914E+08 6.956E+26 4.975E-01 4.983E-01 0.00421325
-4.459E+07 1.284E+09 3.858E+08 6.734E+26 4.975E-01 4.983E-01 0.00421225
-4.541E+07 1.252E+09 3.801E+08 6.514E+26 4.975E-01 4.983E-01 0.00421124
-4.624E+07 1.221E+09 3.744E+08 6.294E+26 4.975E-01 4.983E-01 0.00421024
-4.709E+07 1.189E+09 3.686E+08 6.075E+26 4.975E-01 4.983E-01 0.00420923
-4.795E+07 1.157E+09 3.627E+08 5.858E+26 4.975E-01 4.983E-01 0.00420822
-4.882E+07 1.125E+09 3.568E+08 5.644E+26 4.975E-01 4.983E-01 0.00420722
-4.971E+07 1.094E+09 3.508E+08 5.431E+26 4.975E-01 4.983E-01 0.00420621
-5.061E+07 1.062E+09 3.448E+08 5.222E+26 4.975E-01 4.983E-01 0.00420521
-5.151E+07 1.031E+09 3.387E+08 5.016E+26 4.975E-01 4.983E-01 0.0042042
-5.243E+07 9.998E+08 3.327E+08 4.814E+26 4.975E-01 4.983E-01 0.0042032
-5.336E+07 9.690E+08 3.266E+08 4.616E+26 4.975E-01 4.983E-01 0.00420219
-5.430E+07 9.385E+08 3.206E+08 4.422E+26 4.975E-01 4.983E-01 0.00420119
-5.525E+07 9.085E+08 3.145E+08 4.232E+26 4.975E-01 4.983E-01 0.00420018
-5.620E+07 8.788E+08 3.084E+08 4.048E+26 4.975E-01 4.983E-01 0.00419918
-5.716E+07 8.496E+08 3.024E+08 3.868E+26 4.975E-01 4.983E-01 0.00419817
-5.813E+07 8.209E+08 2.964E+08 3.693E+26 4.975E-01 4.983E-01 0.00419616
-5.911E+07 7.928E+08 2.905E+08 3.524E+26 4.975E-01 4.983E-01 0.00419516
-6.009E+07 7.652E+08 2.846E+08 3.360E+26 4.975E-01 4.983E-01 0.00419415
-6.107E+07 7.383E+08 2.788E+08 3.202E+26 4.975E-01 4.983E-01 0.00419315
-6.206E+07 7.120E+08 2.730E+08 3.049E+26 4.975E-01 4.983E-01 0.00419214
-6.305E+07 6.863E+08 2.673E+08 2.902E+26 4.975E-01 4.983E-01 0.00419114
-6.405E+07 6.613E+08 2.617E+08 2.760E+26 4.975E-01 4.983E-01 0.00419013
-6.504E+07 6.370E+08 2.562E+08 2.625E+26 4.975E-01 4.983E-01 0.00418913
-6.604E+07 6.134E+08 2.507E+08 2.494E+26 4.975E-01 4.983E-01 0.00418812
-6.703E+07 5.905E+08 2.454E+08 2.370E+26 4.975E-01 4.983E-01 0.00418712
-6.802E+07 5.684E+08 2.402E+08 2.251E+26 4.975E-01 4.983E-01 0.00418611
-6.901E+07 5.470E+08 2.351E+08 2.137E+26 4.975E-01 4.983E-01 0.00418511
-7.000E+07 5.263E+08 2.301E+08 2.029E+26 4.975E-01 4.983E-01 0.0041841
-7.098E+07 5.064E+08 2.252E+08 1.926E+26 4.975E-01 4.983E-01 0.0041831
-7.195E+07 4.872E+08 2.204E+08 1.829E+26 4.975E-01 4.983E-01 0.00418209
-7.292E+07 4.688E+08 2.158E+08 1.736E+26 4.975E-01 4.983E-01 0.00418109
-7.389E+07 4.510E+08 2.112E+08 1.648E+26 4.975E-01 4.983E-01 0.00418008
-7.485E+07 4.339E+08 2.068E+08 1.564E+26 4.975E-01 4.983E-01 0.00417908
-7.581E+07 4.174E+08 2.025E+08 1.484E+26 4.975E-01 4.983E-01 0.00417807
-7.676E+07 4.016E+08 1.983E+08 1.408E+26 4.975E-01 4.983E-01 0.00417707
-7.771E+07 3.863E+08 1.942E+08 1.336E+26 4.975E-01 4.983E-01 0.00417706
-7.866E+07 3.715E+08 1.902E+08 1.268E+26 4.975E-01 4.983E-01 0.00417606
-7.961E+07 3.573E+08 1.863E+08 1.203E+26 4.975E-01 4.983E-01 0.00417506
-8.056E+07 3.436E+08 1.824E+08 1.141E+26 4.975E-01 4.983E-01 0.00417405
-8.150E+07 3.303E+08 1.787E+08 1.081E+26 4.975E-01 4.983E-01 0.00417305
-8.245E+07 3.175E+08 1.750E+08 1.025E+26 4.975E-01 4.983E-01 0.00417304
-8.340E+07 3.052E+08 1.715E+08 9.716E+25 4.975E-01 4.983E-01 0.00417204
-8.434E+07 2.933E+08 1.680E+08 9.205E+25 4.975E-01 4.983E-01 0.00417104
-8.529E+07 2.817E+08 1.645E+08 8.719E+25 4.975E-01 4.983E-01 0.00417103
-8.624E+07 2.706E+08 1.612E+08 8.256E+25 4.975E-01 4.983E-01 0.00417003
-8.719E+07 2.599E+08 1.579E+08 7.814E+25 4.975E-01 4.983E-01 0.00417003
-8.815E+07 2.495E+08 1.547E+08 7.394E+25 4.975E-01 4.983E-01 0.00416903
-8.911E+07 2.394E+08 1.515E+08 6.993E+25 4.975E-01 4.983E-01 0.00416902
-9.007E+07 2.297E+08 1.484E+08 6.611E+25 4.975E-01 4.983E-01 0.00416802
-9.103E+07 2.204E+08 1.454E+08 6.247E+25 4.975E-01 4.983E-01 0.00416802
-9.200E+07 2.113E+08 1.424E+08 5.900E+25 4.975E-01 4.983E-01 0.00416802
-9.298E+07 2.025E+08 1.395E+08 5.569E+25 4.975E-01 4.983E-01 0.00416702
-9.396E+07 1.940E+08 1.366E+08 5.254E+25 4.975E-01 4.983E-01 0.00416702
-9.495E+07 1.858E+08 1.334E+08 4.953E+25 5.000E-01 5.000E-01 5.79985e-11
-9.594E+07 1.778E+08 1.327E+08 4.667E+25 5.000E-01 5.000E-01 7.477e-25
-9.694E+07 1.701E+08 1.319E+08 4.394E+25 5.000E-01 5.000E-01 4.568e-25
-9.795E+07 1.627E+08 1.312E+08 4.133E+25 5.000E-01 5.000E-01 2.782e-25
-9.897E+07 1.554E+08 1.305E+08 3.886E+25 5.000E-01 5.000E-01 1.688e-25
-1.000E+08 1.484E+08 1.298E+08 3.649E+25 5.000E-01 5.000E-01 1.021e-25
-1.010E+08 1.417E+08 1.290E+08 3.424E+25 5.000E-01 5.000E-01 6.149e-26
-1.021E+08 1.351E+08 1.283E+08 3.210E+25 5.000E-01 5.000E-01 3.688e-26
-1.032E+08 1.288E+08 1.276E+08 3.006E+25 5.000E-01 5.000E-01 2.202e-26
-1.042E+08 1.226E+08 1.269E+08 2.812E+25 5.000E-01 5.000E-01 1.308e-26
-1.053E+08 1.167E+08 1.262E+08 2.627E+25 5.000E-01 5.000E-01 7.725e-27
-1.064E+08 1.109E+08 1.254E+08 2.451E+25 5.000E-01 5.000E-01 4.536e-27
-1.076E+08 1.053E+08 1.247E+08 2.283E+25 5.000E-01 5.000E-01 2.646e-27
-1.087E+08 9.991E+07 1.240E+08 2.124E+25 5.000E-01 5.000E-01 1.531e-27
-1.099E+08 9.467E+07 1.233E+08 1.972E+25 5.000E-01 5.000E-01 8.792e-28
-1.111E+08 8.958E+07 1.225E+08 1.828E+25 5.000E-01 5.000E-01 5.003e-28
-1.123E+08 8.465E+07 1.218E+08 1.692E+25 5.000E-01 5.000E-01 2.819e-28
-1.135E+08 7.988E+07 1.210E+08 1.562E+25 5.000E-01 5.000E-01 1.572e-28
-1.148E+08 7.525E+07 1.203E+08 1.439E+25 5.000E-01 5.000E-01 8.658e-29
-1.161E+08 7.077E+07 1.195E+08 1.322E+25 5.000E-01 5.000E-01 4.707e-29
-1.174E+08 6.642E+07 1.187E+08 1.211E+25 5.000E-01 5.000E-01 2.521e-29
-1.188E+08 6.220E+07 1.180E+08 1.106E+25 5.000E-01 5.000E-01 1.328e-29
-1.202E+08 5.806E+07 1.171E+08 1.006E+25 5.000E-01 5.000E-01 6.812e-30
-1.218E+08 5.390E+07 1.163E+08 9.071E+24 5.000E-01 5.000E-01 3.326e-30
-1.235E+08 4.961E+07 1.153E+08 8.086E+24 5.000E-01 5.000E-01 1.503e-30
-1.256E+08 4.509E+07 1.142E+08 7.080E+24 5.000E-01 5.000E-01 6.049e-31
-1.280E+08 4.021E+07 1.129E+08 6.035E+24 5.000E-01 5.000E-01 2.04e-31
-1.308E+08 3.519E+07 1.115E+08 5.009E+24 5.000E-01 5.000E-01 5.759e-32
-1.338E+08 3.027E+07 1.098E+08 4.057E+24 5.000E-01 5.000E-01 1.373e-32
-1.372E+08 2.547E+07 1.078E+08 3.182E+24 5.000E-01 5.000E-01 2.568e-33
-1.411E+08 2.077E+07 1.053E+08 2.384E+24 5.000E-01 5.000E-01 3.29e-34
-1.459E+08 1.615E+07 1.020E+08 1.666E+24 5.000E-01 5.000E-01 2.182e-35
-1.521E+08 1.158E+07 9.686E+07 1.034E+24 5.000E-01 5.000E-01 0
-1.614E+08 6.976E+06 8.675E+07 4.943E+23 5.000E-01 5.000E-01 0
diff --git a/Util/initial_models/lagrangian_planar/GNUmakefile b/Util/initial_models/lagrangian_planar/GNUmakefile
deleted file mode 100644
index c9422ecfe..000000000
--- a/Util/initial_models/lagrangian_planar/GNUmakefile
+++ /dev/null
@@ -1,32 +0,0 @@
-# Makefile for the init_1d initial model generator
-
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../..
-
-
-# EOS and network
-EOS_DIR := helmeos
-
-NETWORK_DIR := general_null
-GENERAL_NET_INPUTS := $(MAESTRO_TOP_DIR)/Microphysics/networks/$(NETWORK_DIR)/xrb.net
-
-
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d.f90
-
-
-include ../GInitModels.mak
-
-
-
-
diff --git a/Util/initial_models/lagrangian_planar/README b/Util/initial_models/lagrangian_planar/README
deleted file mode 100644
index 1a6a9499e..000000000
--- a/Util/initial_models/lagrangian_planar/README
+++ /dev/null
@@ -1,3 +0,0 @@
-This is a generic initial model routine that takes an starting model
-from a 1-d Lagrangian stellar evolution code and puts it onto a
-uniform grid and then enforces HSE.
\ No newline at end of file
diff --git a/Util/initial_models/lagrangian_planar/_params b/Util/initial_models/lagrangian_planar/_params
deleted file mode 100644
index 3828068b3..000000000
--- a/Util/initial_models/lagrangian_planar/_params
+++ /dev/null
@@ -1,20 +0,0 @@
-¶ms
-
- model_file = "xrb_new.raw"
-
- model_prefix = "xrb_new"
-
- nx = 1536
-
- temp_cutoff = 1.d6
-
- model_shift = 1.e6
-
- xmin = 0.0
- xmax = 9216.0
-
- g_const = -2.4679d14
-
- low_density_cutoff = 1.d-4
-
-/
diff --git a/Util/initial_models/lagrangian_planar/init_1d.f90 b/Util/initial_models/lagrangian_planar/init_1d.f90
deleted file mode 100755
index 9995536b1..000000000
--- a/Util/initial_models/lagrangian_planar/init_1d.f90
+++ /dev/null
@@ -1,530 +0,0 @@
-!! The model is placed into HSE by the following differencing:
-!!
-!! (1/dr) [ _i -
_{i-1} ] = (1/2) [ _i + _{i-1} ] g
-!!
-!! This will be iterated over in tandem with the EOS call,
-!! P(i-1) = P_eos(rho(i-1), T(i-1), X(i-1)
-!!
-
-program init_1d
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use eos_module, only: eos_input_rt, eos, eos_init
- use eos_type_module, only: eos_t
- use extern_probin_module, only: use_eos_coulomb
- use network, only : nspec, network_species_index, spec_names, network_init
- use fundamental_constants_module, only: Gconst
- use model_parser_module
-
- implicit none
-
- integer :: i, n
-
- character(len=128) :: params_file
-
- real (kind=dp_t), DIMENSION(nspec) :: xn
-
- real (kind=dp_t), allocatable :: xzn_hse(:), xznl_hse(:), xznr_hse(:)
- real (kind=dp_t), allocatable :: model_hse(:,:)
-
- real :: A
-
- integer ::nx
-
- integer :: lun1, lun2
-
- real (kind=dp_t) :: xmin, xmax, dCoord
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone, entropy
- real (kind=dp_t) :: dpd
-
- real (kind=dp_t) :: p_want, drho, dtemp, delx
-
- real (kind=dp_t) :: g_zone, g_const, M_enclosed
- logical :: do_invsq_grav
-
- real (kind=dp_t), parameter :: TOL = 1.e-10
-
- integer, parameter :: MAX_ITER = 250
-
- integer :: iter
-
- logical :: converged_hse, fluff
-
- real (kind=dp_t) :: low_density_cutoff, temp_cutoff, smallx, max_T
- real (kind=dp_t) :: model_shift
-
- integer :: index_base
-
- character (len=256) :: outfile, outfile2
- character (len=8) :: num
- character (len=32) :: dxstr
- character (len=32) :: num_to_unitstring
- character (len=64) :: model_file
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- character (len=128) :: model_prefix
-
- integer :: narg
-
- type (eos_t) :: eos_state
-
- namelist /params/ nx, model_file, xmin, xmax, g_const, &
- temp_cutoff, do_invsq_grav, &
- low_density_cutoff, model_prefix, model_shift
-
- ! determine if we specified a runtime parameters file or use the default
- narg = command_argument_count()
-
- if (narg == 0) then
- params_file = "_params"
- else
- call get_command_argument(1, value = params_file)
- endif
-
-
- ! define defaults for the parameters for this model
- nx = 640
-
- model_file = "model.in"
-
- model_shift = 0.0_dp_t
-
- xmin = 0.0_dp_t
- xmax = 2.e3_dp_t
-
- do_invsq_grav = .false.
- g_const = -1.0
-
- model_prefix = "model"
-
- low_density_cutoff = 1.d-4
- temp_cutoff = 1.d6
-
- smallx = 1.d-10
-
-
- ! this comes in via extern_probin_module -- override the default
- ! here if we want
- use_eos_coulomb = .true.
-
-
- ! initialize the EOS and network
- call eos_init()
- call network_init()
-
- ! check the namelist for any changed parameters
- open(unit=11, file=params_file, status="old", action="read")
- read(unit=11, nml=params)
- close(unit=11)
-
-
- ! start by reading in the Lagrangian initial model
- call read_model_file(model_file)
-
- ! apply the shift
- do i = 1, npts_model
- model_r(i) = model_r(i) - model_shift
- enddo
-
-
-!-----------------------------------------------------------------------------
-! Create a 1-d uniform grid that is identical to the mesh that we are
-! mapping onto, and then we want to force it into HSE on that mesh.
-!-----------------------------------------------------------------------------
-
- ! allocate storage
- allocate(xzn_hse(nx))
- allocate(xznl_hse(nx))
- allocate(xznr_hse(nx))
- allocate(model_hse(nx,nvars_model))
-
-
- ! compute the coordinates of the new gridded function
- dCoord = (xmax - xmin) / dble(nx)
-
- do i = 1, nx
- xznl_hse(i) = xmin + (dble(i) - ONE)*dCoord
- xzn_hse(i) = xmin + (dble(i) - HALF)*dCoord
- xznr_hse(i) = xmin + (dble(i))*dCoord
- enddo
-
-
-!-----------------------------------------------------------------------------
-! put the model onto our new uniform grid
-!-----------------------------------------------------------------------------
-
- fluff = .false.
-
- do i = 1, nx
- do n = 1, nvars_model
- if (n == itemp_model) then
- model_hse(i,n) = max(temp_cutoff, interpolate(xzn_hse(i), n, interpolate_top=.true.))
- else
- model_hse(i,n) = interpolate(xzn_hse(i), n)
- endif
- enddo
-
- ! make it all thermodynamically consistent
- eos_state%rho = model_hse(i,idens_model)
- eos_state%T = model_hse(i,itemp_model)
- eos_state%xn(:) = model_hse(i,ispec_model:ispec_model-1+nspec)
-
- call eos(eos_input_rt, eos_state)
-
- model_hse(i,ipres_model) = eos_state%p
- enddo
-
-
- ! find the index to integrate from by looking for the peak temperature
- index_base = -1
- max_T = -1.0_dp_t
-
- do i = 1, nx
- if (model_hse(i,itemp_model) > max_T) then
- index_base = i
- max_T = model_hse(i,itemp_model)
- endif
- enddo
-
- if (index_base == -1) then
- call bl_error('ERROR: invalid base_height')
- endif
-
- print *, 'index_base = ', index_base
-
- ! make the base thermodynamics consistent for this base point -- that is
- ! what we will integrate from!
- eos_state%rho = model_hse(index_base,idens_model)
- eos_state%T = model_hse(index_base,itemp_model)
- eos_state%xn(:) = model_hse(index_base,ispec_model:ispec_model-1+nspec)
-
- call eos(eos_input_rt, eos_state)
-
- model_hse(index_base,ipres_model) = eos_state%p
-
-
-!-----------------------------------------------------------------------------
-! HSE + entropy solve
-!-----------------------------------------------------------------------------
-
- ! the HSE state will be done respecting the interpolated temperature
- ! from the initial model. When the temperature drops below T_lo,
- ! we floor it.
-
- !---------------------------------------------------------------------------
- ! integrate up
- !---------------------------------------------------------------------------
- do i = index_base+1, nx
-
- delx = xzn_hse(i) - xzn_hse(i-1)
-
- ! compute the gravitation acceleration at the lower edge
- if (do_invsq_grav) then
- g_zone = -Gconst*M_enclosed/xznl_hse(i)**2
- else
- g_zone = g_const
- endif
-
- ! we've already set initial guesses for density, temperature, and
- ! composition
- dens_zone = model_hse(i,idens_model)
- temp_zone = max(temp_cutoff, model_hse(i,itemp_model))
- xn(:) = model_hse(i,ispec_model:ispec_model-1+nspec)
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- do iter = 1, MAX_ITER
-
- ! what pressure does HSE say we want?
- p_want = model_hse(i-1,ipres_model) + &
- delx*0.5*(dens_zone + model_hse(i-1,idens_model))*g_zone
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
- dens_zone = low_density_cutoff
- temp_zone = temp_cutoff
- converged_hse = .TRUE.
- exit
- endif
-
- enddo
-
-
- if (.NOT. converged_hse) then
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho, dtemp
- call bl_error('Error: HSE non-convergence')
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! update the thermodynamics in this zone
- model_hse(i,idens_model) = dens_zone
- model_hse(i,itemp_model) = temp_zone
- model_hse(i,ipres_model) = pres_zone
-
- ! to make this process converge faster, set the density in the
- ! next zone to the density in this zone
- ! model_hse(i+1,idens) = dens_zone
-
- enddo
-
-
- !---------------------------------------------------------------------------
- ! integrate down -- using the temperature profile defined above
- !---------------------------------------------------------------------------
- do i = index_base-1, 1, -1
-
- delx = xzn_hse(i+1) - xzn_hse(i)
-
- ! compute the gravitation acceleration at the upper edge
- if (do_invsq_grav) then
- g_zone = -Gconst*M_enclosed/xznr_hse(i)**2
- else
- g_zone = g_const
- endif
-
- ! we already set the temperature and composition profiles
- temp_zone = max(temp_cutoff, model_hse(i,itemp_model))
- xn(:) = model_hse(i,ispec_model:ispec_model-1+nspec)
-
- ! use our previous initial guess for density
- dens_zone = model_hse(i,idens_model)
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- do iter = 1, MAX_ITER
-
- ! get the pressure we want from the HSE equation, just the
- ! zone below the current. Note, we are using an average of
- ! the density of the two zones as an approximation of the
- ! interface value -- this means that we need to iterate for
- ! find the density and pressure that are consistent
-
- ! HSE differencing
- p_want = model_hse(i+1,ipres_model) - &
- delx*0.5*(dens_zone + model_hse(i+1,idens_model))*g_zone
-
-
- ! we will take the temperature already defined in model_hse
- ! so we only need to zero:
- ! A = p_want - p(rho)
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- A = p_want - pres_zone
-
- drho = A/(dpd + 0.5*delx*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate down'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! update the thermodynamics in this zone
- model_hse(i,idens_model) = dens_zone
- model_hse(i,itemp_model) = temp_zone
- model_hse(i,ipres_model) = pres_zone
-
- enddo
-
- write(num,'(i8)') nx
-
- dxstr = num_to_unitstring(dCoord)
-
- outfile = trim(model_prefix) // ".hse" // ".dx_" // trim(adjustl(dxstr))
- outfile2 = trim(outfile) // ".extras"
-
- open (newunit=lun1, file=outfile, status="unknown")
- open (newunit=lun2, file=outfile2, status="unknown")
-
- write (lun1,1001) "# npts = ", nx
- write (lun1,1001) "# num of variables = ", nvars_model
- write (lun1,1002) "# density"
- write (lun1,1002) "# temperature"
- write (lun1,1002) "# pressure"
-
- do n = 1, nspec
- write (lun1, 1003) "# ", spec_names(n)
- enddo
-
-1000 format (1x, 100(g26.16, 1x))
-1001 format (a, i5)
-1002 format (a)
-1003 format (a,a)
-
- do i = 1, nx
- write (lun1,1000) xzn_hse(i), model_hse(i,idens_model), &
- model_hse(i,itemp_model), model_hse(i,ipres_model), &
- (model_hse(i,ispec_model-1+n), n=1,nspec)
- enddo
-
-
- write (lun2,1001), "# npts = ", nx
- write (lun2,1001), "# num of variables = ", 2
- write (lun2,1002), "# entropy"
- write (lun2,1002), "# c_s"
-
- ! test: bulk EOS call -- Maestro will do this once we are mapped, so make
- ! sure that we are in HSE with updated thermodynamics
- do i = 1, nx
- eos_state%rho = model_hse(i,idens_model)
- eos_state%T = model_hse(i,itemp_model)
- eos_state%xn(:) = model_hse(i,ispec_model:ispec_model-1+nspec)
-
- call eos(eos_input_rt, eos_state)
-
- model_hse(i,ipres_model) = eos_state%p
-
- write (lun2,1000), xzn_hse(i), eos_state%s, eos_state%cs
- enddo
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
-
- ! compute the gravitation acceleration at the lower edge
- if (do_invsq_grav) then
- g_zone = -Gconst*M_enclosed/xznl_hse(i)**2
- else
- g_zone = g_const
- endif
-
- dpdr = (model_hse(i,ipres_model) - model_hse(i-1,ipres_model))/delx
- rhog = HALF*(model_hse(i,idens_model) + model_hse(i-1,idens_model))*g_zone
-
- if (dpdr /= ZERO .and. model_hse(i+1,idens_model) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
-
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
- close (unit=lun1)
- close (unit=lun2)
-
-end program init_1d
-
-
-function num_to_unitstring(value)
-
- use bl_types
- implicit none
-
- real (kind=dp_t) :: value
- character (len=32) :: num_to_unitstring
- character (len=16) :: temp
-
- if (value > 1.d5) then
-
- ! work in km
- write(temp,'(f6.3)') value/1.d5
- num_to_unitstring = trim(temp) // "km"
- else
-
- ! work in cm
- if (value > 1.d3) then
- write(temp,'(f8.3)') value
- num_to_unitstring = trim(temp) // "cm"
-
- else
- write(temp,'(f6.3)') value
- num_to_unitstring = trim(temp) // "cm"
- endif
-
- endif
-
- return
-end function num_to_unitstring
-
-
diff --git a/Util/initial_models/lagrangian_planar/xrb_new.raw b/Util/initial_models/lagrangian_planar/xrb_new.raw
deleted file mode 100644
index d974d0f29..000000000
--- a/Util/initial_models/lagrangian_planar/xrb_new.raw
+++ /dev/null
@@ -1,263 +0,0 @@
-# npts = 252
-# num of variables = 9
-# density
-# temperature
-# hydrogen-1
-# helium-4
-# oxygen-14
-# oxygen-15
-# neon-18
-# silicon-25
-# iron-56
-1.00008618042101E+06 9.23302682790944E+08 3.29269045589696E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00018246111284E+06 8.86362789687716E+08 3.25125720733078E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00028908937672E+06 8.46452036629534E+08 3.20997887050845E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00040618790956E+06 8.03850709654461E+08 3.17025333400611E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00053374746912E+06 7.58919881965912E+08 3.13347919950076E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00067162257214E+06 7.12092438697396E+08 3.10087542753234E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00081953024873E+06 6.63860428635514E+08 3.07330214751293E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00097705178469E+06 6.14759355703278E+08 3.05113488773483E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00114363730615E+06 5.65350245796678E+08 3.03423600359085E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00131861299650E+06 5.16200490169289E+08 3.02203462423815E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00150119068129E+06 4.67864553847318E+08 3.01368489449750E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00169047947013E+06 4.20865633638680E+08 3.00824445401068E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00188549910605E+06 3.75679255652768E+08 3.00481569780298E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00208519464427E+06 3.32719631929722E+08 3.00261749397917E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00228845206455E+06 2.92329373758630E+08 3.00098544709595E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00249411441555E+06 2.54772909362727E+08 2.99932180934760E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00270099809459E+06 2.20233698306052E+08 2.99702528683171E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00290790888081E+06 1.88815093130160E+08 2.99343035216472E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00311365736131E+06 1.60544487515986E+08 2.98777863481069E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00331707341713E+06 1.35380222843691E+08 2.97923652239319E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00351701946483E+06 1.13220610616416E+08 2.96696505168268E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00371240216725E+06 9.39143758435059E+07 2.95020115592347E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00390218233655E+06 7.72718189781714E+07 2.92831923667458E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00408538276858E+06 6.30760320965910E+07 2.90090516983872E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00426109373148E+06 5.10936029441377E+07 2.86779462737335E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00442847582394E+06 4.10843453586947E+07 2.82909089541650E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00458675992985E+06 3.28097244237698E+07 2.78517695263099E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00473524408745E+06 2.60397751324809E+07 2.73674269309476E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00487328739615E+06 2.05584346027073E+07 2.68485026163459E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00500030186795E+06 1.61673106948346E+07 2.63106142299657E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00511574486111E+06 1.26879876948185E+07 2.57765500185429E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00521911803882E+06 9.96302062757611E+06 2.52794773759511E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00530998403166E+06 7.85579351592707E+06 2.48670397185478E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00538801772050E+06 6.24942070601667E+06 2.46060754223609E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00545311093243E+06 5.04472706431292E+06 2.45885362822611E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00550552006606E+06 4.15834953383713E+06 2.49476548152403E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00554602889722E+06 3.51898124516807E+06 2.59335214109035E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00557602933638E+06 3.06296173952048E+06 2.83677637580794E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00559748742648E+06 2.72033831302002E+06 3.52152303536510E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00561264088484E+06 2.41138526645067E+06 4.97531112170017E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00562301040122E+06 2.17360449492526E+06 6.20881721086849E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00563014083935E+06 2.02996104095443E+06 6.86611906407977E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00563513184202E+06 1.93834805735128E+06 7.26100026998387E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00563871616881E+06 1.87689896331296E+06 7.51779242739126E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00564136965036E+06 1.83380183185681E+06 7.69467667183029E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00564340037686E+06 1.80227237156341E+06 7.82260447720732E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00564500981475E+06 1.77824161565526E+06 7.91934239793935E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00564633219813E+06 1.75918032374180E+06 7.99565182934076E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00564745940647E+06 1.74344758968340E+06 8.05836150353750E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00564845668302E+06 1.72994080337322E+06 8.11200394100794E+08 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 1.000E+00
-1.00565086089968E+06 6.546E+05 8.161E+08 6.041E-01 1.700E-01 2.305E-05 4.983E-05 2.588E-03 6.616E-02 3.238E-28
-1.00565328458428E+06 6.493E+05 8.199E+08 6.044E-01 1.703E-01 2.185E-05 4.130E-05 2.217E-03 6.641E-02 3.022E-28
-1.00565572671543E+06 6.444E+05 8.228E+08 6.049E-01 1.709E-01 2.101E-05 3.699E-05 2.018E-03 6.635E-02 2.874E-28
-1.00565830101129E+06 6.113E+05 8.249E+08 6.565E-01 2.114E-01 2.985E-05 1.756E-05 1.587E-03 4.425E-02 8.843E-29
-1.00566095102885E+06 5.938E+05 8.265E+08 6.820E-01 2.457E-01 3.852E-05 2.751E-05 1.998E-03 1.918E-02 3.744E-29
-1.00566361861433E+06 5.899E+05 8.278E+08 6.829E-01 2.476E-01 3.825E-05 5.181E-05 2.416E-03 1.562E-02 3.786E-29
-1.00566630269323E+06 5.863E+05 8.288E+08 6.835E-01 2.491E-01 3.799E-05 1.036E-04 3.159E-03 1.297E-02 3.872E-29
-1.00566900245059E+06 5.829E+05 8.294E+08 6.842E-01 2.503E-01 3.771E-05 2.018E-04 4.395E-03 1.093E-02 4.005E-29
-1.00567171714350E+06 5.797E+05 8.297E+08 6.849E-01 2.517E-01 3.781E-05 4.147E-04 6.767E-03 9.569E-03 4.261E-29
-1.00567444572411E+06 5.767E+05 8.294E+08 6.857E-01 2.534E-01 3.826E-05 8.115E-04 1.076E-02 8.865E-03 4.829E-29
-1.00567718590618E+06 5.743E+05 8.284E+08 6.861E-01 2.549E-01 4.423E-05 1.258E-03 1.497E-02 8.687E-03 1.161E-28
-1.00567993533455E+06 5.723E+05 8.269E+08 6.861E-01 2.549E-01 4.533E-05 1.263E-03 1.504E-02 8.687E-03 1.298E-28
-1.00568269408595E+06 5.704E+05 8.254E+08 6.861E-01 2.549E-01 4.626E-05 1.268E-03 1.510E-02 8.686E-03 1.406E-28
-1.00568546223938E+06 5.685E+05 8.239E+08 6.861E-01 2.549E-01 4.713E-05 1.273E-03 1.516E-02 8.685E-03 1.497E-28
-1.00568823987533E+06 5.665E+05 8.223E+08 6.861E-01 2.550E-01 4.805E-05 1.278E-03 1.522E-02 8.685E-03 1.599E-28
-1.00569102707560E+06 5.646E+05 8.208E+08 6.861E-01 2.550E-01 4.903E-05 1.283E-03 1.528E-02 8.684E-03 1.719E-28
-1.00569382392327E+06 5.626E+05 8.192E+08 6.861E-01 2.550E-01 5.007E-05 1.288E-03 1.534E-02 8.684E-03 1.862E-28
-1.00569663050265E+06 5.607E+05 8.177E+08 6.861E-01 2.550E-01 5.120E-05 1.293E-03 1.540E-02 8.683E-03 2.045E-28
-1.00569944689933E+06 5.587E+05 8.161E+08 6.861E-01 2.550E-01 5.244E-05 1.298E-03 1.546E-02 8.683E-03 2.302E-28
-1.00570227320018E+06 5.568E+05 8.145E+08 6.861E-01 2.550E-01 5.368E-05 1.302E-03 1.551E-02 8.682E-03 2.614E-28
-1.00570510949332E+06 5.548E+05 8.129E+08 6.861E-01 2.551E-01 5.470E-05 1.307E-03 1.556E-02 8.682E-03 2.791E-28
-1.00570795586822E+06 5.528E+05 8.114E+08 6.861E-01 2.551E-01 5.576E-05 1.311E-03 1.561E-02 8.681E-03 2.994E-28
-1.00571081241564E+06 5.509E+05 8.098E+08 6.861E-01 2.551E-01 5.688E-05 1.316E-03 1.566E-02 8.681E-03 3.232E-28
-1.00571367922771E+06 5.489E+05 8.082E+08 6.861E-01 2.551E-01 5.807E-05 1.320E-03 1.571E-02 8.680E-03 3.521E-28
-1.00571655639794E+06 5.469E+05 8.066E+08 6.861E-01 2.551E-01 5.934E-05 1.325E-03 1.576E-02 8.680E-03 3.891E-28
-1.00571944402120E+06 5.449E+05 8.050E+08 6.861E-01 2.551E-01 6.071E-05 1.329E-03 1.581E-02 8.680E-03 4.408E-28
-1.00572234219385E+06 5.429E+05 8.034E+08 6.861E-01 2.552E-01 6.221E-05 1.334E-03 1.585E-02 8.679E-03 5.244E-28
-1.00572525101364E+06 5.409E+05 8.017E+08 6.861E-01 2.552E-01 6.338E-05 1.338E-03 1.590E-02 8.679E-03 5.657E-28
-1.00572817057985E+06 5.389E+05 8.001E+08 6.861E-01 2.552E-01 6.446E-05 1.342E-03 1.594E-02 8.678E-03 5.886E-28
-1.00573110099326E+06 5.369E+05 7.985E+08 6.861E-01 2.552E-01 6.573E-05 1.346E-03 1.598E-02 8.678E-03 6.415E-28
-1.00573404235618E+06 5.349E+05 7.968E+08 6.861E-01 2.552E-01 6.705E-05 1.350E-03 1.602E-02 8.678E-03 7.049E-28
-1.00573699477251E+06 5.329E+05 7.952E+08 6.861E-01 2.552E-01 6.841E-05 1.354E-03 1.606E-02 8.677E-03 7.793E-28
-1.00573995834775E+06 5.309E+05 7.935E+08 6.861E-01 2.552E-01 6.981E-05 1.358E-03 1.610E-02 8.677E-03 8.706E-28
-1.00574293318905E+06 5.289E+05 7.919E+08 6.861E-01 2.552E-01 7.127E-05 1.362E-03 1.614E-02 8.677E-03 9.878E-28
-1.00574591940524E+06 5.269E+05 7.902E+08 6.861E-01 2.553E-01 7.279E-05 1.366E-03 1.617E-02 8.677E-03 1.149E-27
-1.00574891710686E+06 5.249E+05 7.885E+08 6.861E-01 2.553E-01 7.424E-05 1.369E-03 1.621E-02 8.676E-03 1.317E-27
-1.00575192640618E+06 5.228E+05 7.869E+08 6.862E-01 2.553E-01 7.551E-05 1.373E-03 1.624E-02 8.676E-03 1.415E-27
-1.00575494741729E+06 5.208E+05 7.852E+08 6.862E-01 2.553E-01 7.680E-05 1.376E-03 1.628E-02 8.676E-03 1.522E-27
-1.00575798025609E+06 5.188E+05 7.835E+08 6.862E-01 2.553E-01 7.810E-05 1.380E-03 1.631E-02 8.675E-03 1.639E-27
-1.00576102504035E+06 5.167E+05 7.818E+08 6.862E-01 2.553E-01 7.942E-05 1.383E-03 1.634E-02 8.675E-03 1.768E-27
-1.00576408188974E+06 5.147E+05 7.801E+08 6.862E-01 2.553E-01 8.075E-05 1.387E-03 1.637E-02 8.675E-03 1.909E-27
-1.00576715092590E+06 5.127E+05 7.783E+08 6.862E-01 2.553E-01 8.209E-05 1.390E-03 1.640E-02 8.674E-03 2.065E-27
-1.00577023227243E+06 5.106E+05 7.766E+08 6.862E-01 2.553E-01 8.345E-05 1.393E-03 1.643E-02 8.674E-03 2.239E-27
-1.00577332605502E+06 5.085E+05 7.749E+08 6.862E-01 2.553E-01 8.481E-05 1.397E-03 1.645E-02 8.674E-03 2.434E-27
-1.00577643240140E+06 5.065E+05 7.732E+08 6.862E-01 2.554E-01 8.618E-05 1.400E-03 1.648E-02 8.673E-03 2.652E-27
-1.00577955144146E+06 5.044E+05 7.714E+08 6.862E-01 2.554E-01 8.756E-05 1.403E-03 1.651E-02 8.673E-03 2.897E-27
-1.00578268330726E+06 5.024E+05 7.697E+08 6.862E-01 2.554E-01 8.894E-05 1.406E-03 1.653E-02 8.673E-03 3.173E-27
-1.00578582813311E+06 5.003E+05 7.679E+08 6.862E-01 2.554E-01 9.033E-05 1.409E-03 1.656E-02 8.673E-03 3.487E-27
-1.00578898605560E+06 4.982E+05 7.661E+08 6.862E-01 2.554E-01 9.171E-05 1.412E-03 1.658E-02 8.673E-03 3.848E-27
-1.00579215721364E+06 4.961E+05 7.644E+08 6.862E-01 2.554E-01 9.309E-05 1.415E-03 1.660E-02 8.672E-03 4.259E-27
-1.00579534174857E+06 4.940E+05 7.626E+08 6.862E-01 2.554E-01 9.446E-05 1.418E-03 1.662E-02 8.672E-03 4.735E-27
-1.00579853980416E+06 4.919E+05 7.608E+08 6.862E-01 2.554E-01 9.583E-05 1.421E-03 1.664E-02 8.672E-03 5.296E-27
-1.00580175152669E+06 4.898E+05 7.590E+08 6.862E-01 2.554E-01 9.718E-05 1.424E-03 1.666E-02 8.672E-03 5.969E-27
-1.00580497706504E+06 4.877E+05 7.572E+08 6.862E-01 2.554E-01 9.851E-05 1.426E-03 1.668E-02 8.672E-03 6.758E-27
-1.00580821657070E+06 4.856E+05 7.554E+08 6.862E-01 2.554E-01 9.977E-05 1.429E-03 1.670E-02 8.671E-03 7.265E-27
-1.00581147019786E+06 4.835E+05 7.535E+08 6.862E-01 2.554E-01 1.010E-04 1.432E-03 1.672E-02 8.671E-03 7.817E-27
-1.00581473810348E+06 4.814E+05 7.517E+08 6.862E-01 2.555E-01 1.022E-04 1.434E-03 1.674E-02 8.671E-03 8.417E-27
-1.00581802044738E+06 4.793E+05 7.499E+08 6.862E-01 2.555E-01 1.035E-04 1.437E-03 1.676E-02 8.671E-03 9.072E-27
-1.00582131739226E+06 4.772E+05 7.480E+08 6.862E-01 2.555E-01 1.047E-04 1.439E-03 1.677E-02 8.671E-03 9.787E-27
-1.00582462910380E+06 4.750E+05 7.461E+08 6.862E-01 2.555E-01 1.059E-04 1.442E-03 1.679E-02 8.670E-03 1.057E-26
-1.00582795575075E+06 4.729E+05 7.443E+08 6.862E-01 2.555E-01 1.070E-04 1.444E-03 1.680E-02 8.670E-03 1.143E-26
-1.00583129750498E+06 4.708E+05 7.424E+08 6.862E-01 2.555E-01 1.082E-04 1.446E-03 1.682E-02 8.670E-03 1.238E-26
-1.00583465454160E+06 4.686E+05 7.405E+08 6.862E-01 2.555E-01 1.093E-04 1.449E-03 1.683E-02 8.670E-03 1.343E-26
-1.00583802703900E+06 4.665E+05 7.386E+08 6.862E-01 2.555E-01 1.104E-04 1.451E-03 1.685E-02 8.670E-03 1.458E-26
-1.00584141517895E+06 4.643E+05 7.367E+08 6.862E-01 2.555E-01 1.115E-04 1.453E-03 1.686E-02 8.669E-03 1.598E-26
-1.00584481914671E+06 4.621E+05 7.348E+08 6.862E-01 2.555E-01 1.126E-04 1.455E-03 1.687E-02 8.669E-03 1.755E-26
-1.00584823913109E+06 4.600E+05 7.329E+08 6.862E-01 2.555E-01 1.136E-04 1.458E-03 1.688E-02 8.669E-03 1.934E-26
-1.00585167532458E+06 4.578E+05 7.309E+08 6.862E-01 2.555E-01 1.146E-04 1.460E-03 1.690E-02 8.669E-03 2.138E-26
-1.00585512792342E+06 4.556E+05 7.290E+08 6.862E-01 2.555E-01 1.155E-04 1.462E-03 1.691E-02 8.669E-03 2.380E-26
-1.00585859712772E+06 4.534E+05 7.270E+08 6.862E-01 2.555E-01 1.164E-04 1.464E-03 1.692E-02 8.669E-03 2.621E-26
-1.00586208314155E+06 4.512E+05 7.251E+08 6.862E-01 2.555E-01 1.173E-04 1.466E-03 1.693E-02 8.669E-03 2.821E-26
-1.00586558617306E+06 4.491E+05 7.231E+08 6.862E-01 2.555E-01 1.182E-04 1.468E-03 1.694E-02 8.668E-03 3.038E-26
-1.00586910643461E+06 4.469E+05 7.211E+08 6.862E-01 2.555E-01 1.190E-04 1.469E-03 1.695E-02 8.668E-03 3.277E-26
-1.00587264414284E+06 4.446E+05 7.191E+08 6.862E-01 2.555E-01 1.198E-04 1.471E-03 1.696E-02 8.668E-03 3.537E-26
-1.00587619951883E+06 4.424E+05 7.171E+08 6.862E-01 2.556E-01 1.206E-04 1.473E-03 1.697E-02 8.668E-03 3.820E-26
-1.00587977278824E+06 4.402E+05 7.151E+08 6.862E-01 2.556E-01 1.214E-04 1.475E-03 1.697E-02 8.668E-03 4.128E-26
-1.00588336418138E+06 4.380E+05 7.131E+08 6.862E-01 2.556E-01 1.221E-04 1.476E-03 1.698E-02 8.668E-03 4.464E-26
-1.00588697393341E+06 4.358E+05 7.111E+08 6.862E-01 2.556E-01 1.227E-04 1.478E-03 1.699E-02 8.668E-03 4.831E-26
-1.00589060228443E+06 4.335E+05 7.090E+08 6.862E-01 2.556E-01 1.234E-04 1.480E-03 1.700E-02 8.667E-03 5.234E-26
-1.00589424947967E+06 4.313E+05 7.069E+08 6.862E-01 2.556E-01 1.240E-04 1.481E-03 1.701E-02 8.667E-03 5.678E-26
-1.00589791576962E+06 4.290E+05 7.049E+08 6.862E-01 2.556E-01 1.245E-04 1.483E-03 1.701E-02 8.667E-03 6.169E-26
-1.00590160141016E+06 4.268E+05 7.028E+08 6.862E-01 2.556E-01 1.250E-04 1.485E-03 1.702E-02 8.667E-03 6.719E-26
-1.00590530666279E+06 4.245E+05 7.007E+08 6.862E-01 2.556E-01 1.255E-04 1.486E-03 1.703E-02 8.667E-03 7.350E-26
-1.00590903179473E+06 4.222E+05 6.986E+08 6.862E-01 2.556E-01 1.259E-04 1.488E-03 1.703E-02 8.667E-03 8.126E-26
-1.00591277707913E+06 4.200E+05 6.965E+08 6.862E-01 2.556E-01 1.263E-04 1.489E-03 1.704E-02 8.667E-03 8.753E-26
-1.00591654279526E+06 4.177E+05 6.944E+08 6.862E-01 2.556E-01 1.267E-04 1.490E-03 1.704E-02 8.667E-03 9.397E-26
-1.00592032922868E+06 4.154E+05 6.922E+08 6.862E-01 2.556E-01 1.271E-04 1.492E-03 1.705E-02 8.666E-03 1.000E-25
-1.00592413667145E+06 4.131E+05 6.901E+08 6.862E-01 2.556E-01 1.275E-04 1.493E-03 1.705E-02 8.666E-03 1.077E-25
-1.00592796542233E+06 4.108E+05 6.879E+08 6.862E-01 2.556E-01 1.278E-04 1.494E-03 1.706E-02 8.666E-03 1.160E-25
-1.00593181578700E+06 4.085E+05 6.857E+08 6.862E-01 2.556E-01 1.280E-04 1.496E-03 1.706E-02 8.666E-03 1.250E-25
-1.00593568807828E+06 4.062E+05 6.835E+08 6.862E-01 2.556E-01 1.283E-04 1.497E-03 1.707E-02 8.666E-03 1.347E-25
-1.00593958261636E+06 4.039E+05 6.813E+08 6.862E-01 2.556E-01 1.285E-04 1.498E-03 1.707E-02 8.666E-03 1.453E-25
-1.00594349972905E+06 4.015E+05 6.791E+08 6.862E-01 2.556E-01 1.286E-04 1.499E-03 1.708E-02 8.666E-03 1.567E-25
-1.00594743975200E+06 3.992E+05 6.769E+08 6.862E-01 2.556E-01 1.287E-04 1.501E-03 1.708E-02 8.665E-03 1.694E-25
-1.00595140302904E+06 3.968E+05 6.746E+08 6.862E-01 2.556E-01 1.288E-04 1.502E-03 1.709E-02 8.665E-03 1.837E-25
-1.00595538991236E+06 3.945E+05 6.724E+08 6.862E-01 2.556E-01 1.289E-04 1.503E-03 1.709E-02 8.665E-03 2.009E-25
-1.00595940076287E+06 3.921E+05 6.701E+08 6.862E-01 2.556E-01 1.290E-04 1.504E-03 1.709E-02 8.665E-03 2.146E-25
-1.00596343595044E+06 3.898E+05 6.678E+08 6.862E-01 2.556E-01 1.290E-04 1.505E-03 1.710E-02 8.665E-03 2.292E-25
-1.00596749585427E+06 3.874E+05 6.655E+08 6.862E-01 2.556E-01 1.290E-04 1.506E-03 1.710E-02 8.665E-03 2.447E-25
-1.00597158086317E+06 3.850E+05 6.632E+08 6.862E-01 2.556E-01 1.290E-04 1.507E-03 1.710E-02 8.665E-03 2.612E-25
-1.00597569137594E+06 3.826E+05 6.608E+08 6.862E-01 2.556E-01 1.290E-04 1.508E-03 1.711E-02 8.664E-03 2.789E-25
-1.00597982780168E+06 3.802E+05 6.585E+08 6.862E-01 2.556E-01 1.290E-04 1.509E-03 1.711E-02 8.664E-03 2.981E-25
-1.00598399056020E+06 3.778E+05 6.561E+08 6.862E-01 2.556E-01 1.289E-04 1.510E-03 1.711E-02 8.664E-03 3.190E-25
-1.00598818008241E+06 3.754E+05 6.537E+08 6.862E-01 2.556E-01 1.287E-04 1.511E-03 1.712E-02 8.664E-03 3.472E-25
-1.00599239681069E+06 3.730E+05 6.513E+08 6.862E-01 2.556E-01 1.286E-04 1.512E-03 1.712E-02 8.664E-03 3.731E-25
-1.00599664119938E+06 3.705E+05 6.489E+08 6.862E-01 2.556E-01 1.285E-04 1.513E-03 1.712E-02 8.664E-03 3.965E-25
-1.00600091371518E+06 3.681E+05 6.465E+08 6.862E-01 2.556E-01 1.283E-04 1.514E-03 1.713E-02 8.663E-03 4.214E-25
-1.00600521483762E+06 3.656E+05 6.440E+08 6.862E-01 2.556E-01 1.282E-04 1.514E-03 1.713E-02 8.663E-03 4.477E-25
-1.00600954505958E+06 3.632E+05 6.416E+08 6.862E-01 2.556E-01 1.280E-04 1.515E-03 1.713E-02 8.663E-03 4.755E-25
-1.00601390488781E+06 3.607E+05 6.391E+08 6.862E-01 2.556E-01 1.278E-04 1.516E-03 1.713E-02 8.663E-03 5.051E-25
-1.00601829484345E+06 3.582E+05 6.366E+08 6.862E-01 2.557E-01 1.276E-04 1.517E-03 1.714E-02 8.663E-03 5.368E-25
-1.00602271546259E+06 3.557E+05 6.341E+08 6.862E-01 2.557E-01 1.273E-04 1.518E-03 1.714E-02 8.663E-03 5.715E-25
-1.00602716729694E+06 3.532E+05 6.315E+08 6.862E-01 2.557E-01 1.271E-04 1.518E-03 1.714E-02 8.663E-03 6.106E-25
-1.00603165091437E+06 3.507E+05 6.290E+08 6.862E-01 2.557E-01 1.268E-04 1.519E-03 1.714E-02 8.662E-03 6.565E-25
-1.00603616689965E+06 3.482E+05 6.264E+08 6.862E-01 2.557E-01 1.266E-04 1.520E-03 1.714E-02 8.662E-03 6.910E-25
-1.00604071585510E+06 3.457E+05 6.238E+08 6.862E-01 2.557E-01 1.263E-04 1.520E-03 1.715E-02 8.662E-03 7.281E-25
-1.00604529840136E+06 3.431E+05 6.212E+08 6.862E-01 2.557E-01 1.260E-04 1.521E-03 1.715E-02 8.662E-03 7.664E-25
-1.00604991517815E+06 3.406E+05 6.186E+08 6.862E-01 2.557E-01 1.257E-04 1.522E-03 1.715E-02 8.662E-03 8.101E-25
-1.00605456684509E+06 3.380E+05 6.159E+08 6.862E-01 2.557E-01 1.254E-04 1.523E-03 1.715E-02 8.661E-03 8.579E-25
-1.00605925408260E+06 3.355E+05 6.132E+08 6.862E-01 2.557E-01 1.251E-04 1.523E-03 1.715E-02 8.661E-03 9.118E-25
-1.00606397759276E+06 3.329E+05 6.105E+08 6.863E-01 2.557E-01 1.248E-04 1.524E-03 1.716E-02 8.661E-03 9.632E-25
-1.00606873810031E+06 3.303E+05 6.078E+08 6.863E-01 2.557E-01 1.245E-04 1.524E-03 1.716E-02 8.661E-03 1.009E-24
-1.00607353635366E+06 3.277E+05 6.050E+08 6.863E-01 2.557E-01 1.242E-04 1.525E-03 1.716E-02 8.661E-03 1.056E-24
-1.00607837312600E+06 3.251E+05 6.023E+08 6.863E-01 2.557E-01 1.239E-04 1.526E-03 1.716E-02 8.661E-03 1.107E-24
-1.00608324921640E+06 3.225E+05 5.995E+08 6.863E-01 2.557E-01 1.235E-04 1.526E-03 1.716E-02 8.660E-03 1.162E-24
-1.00608816545106E+06 3.198E+05 5.967E+08 6.863E-01 2.557E-01 1.232E-04 1.527E-03 1.717E-02 8.660E-03 1.230E-24
-1.00609312268461E+06 3.172E+05 5.938E+08 6.863E-01 2.557E-01 1.229E-04 1.527E-03 1.717E-02 8.660E-03 1.283E-24
-1.00609812180141E+06 3.145E+05 5.910E+08 6.863E-01 2.557E-01 1.226E-04 1.528E-03 1.717E-02 8.660E-03 1.335E-24
-1.00610316371708E+06 3.118E+05 5.881E+08 6.863E-01 2.557E-01 1.223E-04 1.529E-03 1.717E-02 8.660E-03 1.391E-24
-1.00610824938000E+06 3.092E+05 5.852E+08 6.863E-01 2.557E-01 1.219E-04 1.529E-03 1.717E-02 8.659E-03 1.450E-24
-1.00611337977298E+06 3.065E+05 5.822E+08 6.863E-01 2.557E-01 1.216E-04 1.530E-03 1.717E-02 8.659E-03 1.515E-24
-1.00611855591499E+06 3.038E+05 5.792E+08 6.863E-01 2.557E-01 1.213E-04 1.530E-03 1.718E-02 8.659E-03 1.580E-24
-1.00612377886302E+06 3.010E+05 5.762E+08 6.863E-01 2.557E-01 1.210E-04 1.531E-03 1.718E-02 8.659E-03 1.633E-24
-1.00612904971408E+06 2.983E+05 5.732E+08 6.863E-01 2.557E-01 1.207E-04 1.531E-03 1.718E-02 8.659E-03 1.693E-24
-1.00613436960736E+06 2.955E+05 5.702E+08 6.863E-01 2.557E-01 1.203E-04 1.532E-03 1.718E-02 8.658E-03 1.759E-24
-1.00613973972643E+06 2.928E+05 5.671E+08 6.863E-01 2.557E-01 1.200E-04 1.532E-03 1.718E-02 8.658E-03 1.823E-24
-1.00614516130171E+06 2.900E+05 5.640E+08 6.863E-01 2.557E-01 1.197E-04 1.533E-03 1.718E-02 8.658E-03 1.877E-24
-1.00615063561309E+06 2.872E+05 5.608E+08 6.863E-01 2.557E-01 1.194E-04 1.533E-03 1.719E-02 8.658E-03 1.941E-24
-1.00615616399268E+06 2.844E+05 5.576E+08 6.863E-01 2.557E-01 1.191E-04 1.534E-03 1.719E-02 8.657E-03 2.001E-24
-1.00616174782782E+06 2.815E+05 5.544E+08 6.863E-01 2.557E-01 1.188E-04 1.534E-03 1.719E-02 8.657E-03 2.057E-24
-1.00616738856431E+06 2.787E+05 5.512E+08 6.863E-01 2.557E-01 1.186E-04 1.535E-03 1.719E-02 8.657E-03 2.123E-24
-1.00617308770983E+06 2.758E+05 5.479E+08 6.863E-01 2.557E-01 1.183E-04 1.535E-03 1.719E-02 8.657E-03 2.176E-24
-1.00617884683771E+06 2.730E+05 5.445E+08 6.863E-01 2.557E-01 1.180E-04 1.536E-03 1.720E-02 8.656E-03 2.237E-24
-1.00618466759090E+06 2.701E+05 5.412E+08 6.863E-01 2.557E-01 1.178E-04 1.536E-03 1.720E-02 8.656E-03 2.290E-24
-1.00619055168637E+06 2.672E+05 5.378E+08 6.863E-01 2.557E-01 1.175E-04 1.537E-03 1.720E-02 8.656E-03 2.356E-24
-1.00619650091969E+06 2.642E+05 5.344E+08 6.863E-01 2.557E-01 1.172E-04 1.537E-03 1.720E-02 8.655E-03 2.410E-24
-1.00620251717021E+06 2.613E+05 5.309E+08 6.863E-01 2.557E-01 1.170E-04 1.537E-03 1.720E-02 8.655E-03 2.463E-24
-1.00620860240648E+06 2.583E+05 5.274E+08 6.863E-01 2.557E-01 1.168E-04 1.538E-03 1.720E-02 8.655E-03 2.515E-24
-1.00621475869225E+06 2.553E+05 5.238E+08 6.863E-01 2.557E-01 1.165E-04 1.538E-03 1.721E-02 8.655E-03 2.567E-24
-1.00622098819294E+06 2.523E+05 5.202E+08 6.863E-01 2.557E-01 1.163E-04 1.539E-03 1.721E-02 8.654E-03 2.611E-24
-1.00622729318268E+06 2.493E+05 5.166E+08 6.863E-01 2.557E-01 1.161E-04 1.539E-03 1.721E-02 8.654E-03 2.672E-24
-1.00623367605202E+06 2.463E+05 5.129E+08 6.863E-01 2.557E-01 1.159E-04 1.540E-03 1.721E-02 8.654E-03 2.706E-24
-1.00624013931636E+06 2.432E+05 5.091E+08 6.863E-01 2.557E-01 1.157E-04 1.540E-03 1.721E-02 8.653E-03 2.753E-24
-1.00624668562509E+06 2.401E+05 5.053E+08 6.863E-01 2.557E-01 1.155E-04 1.541E-03 1.722E-02 8.653E-03 2.798E-24
-1.00625331777167E+06 2.370E+05 5.015E+08 6.863E-01 2.557E-01 1.153E-04 1.541E-03 1.722E-02 8.653E-03 2.843E-24
-1.00626003870475E+06 2.339E+05 4.976E+08 6.863E-01 2.557E-01 1.152E-04 1.542E-03 1.722E-02 8.652E-03 2.886E-24
-1.00626685154027E+06 2.307E+05 4.936E+08 6.863E-01 2.557E-01 1.150E-04 1.542E-03 1.722E-02 8.652E-03 2.930E-24
-1.00627375957491E+06 2.275E+05 4.896E+08 6.863E-01 2.557E-01 1.148E-04 1.543E-03 1.723E-02 8.651E-03 2.973E-24
-1.00628076630092E+06 2.243E+05 4.855E+08 6.863E-01 2.557E-01 1.147E-04 1.543E-03 1.723E-02 8.651E-03 3.016E-24
-1.00628787542250E+06 2.211E+05 4.814E+08 6.863E-01 2.557E-01 1.146E-04 1.544E-03 1.723E-02 8.650E-03 3.063E-24
-1.00629509087401E+06 2.178E+05 4.772E+08 6.863E-01 2.557E-01 1.144E-04 1.544E-03 1.723E-02 8.649E-03 3.103E-24
-1.00630241684027E+06 2.145E+05 4.730E+08 6.863E-01 2.557E-01 1.143E-04 1.545E-03 1.723E-02 8.649E-03 3.140E-24
-1.00630985777908E+06 2.112E+05 4.686E+08 6.863E-01 2.557E-01 1.142E-04 1.546E-03 1.724E-02 8.648E-03 3.177E-24
-1.00631741844651E+06 2.079E+05 4.642E+08 6.863E-01 2.557E-01 1.141E-04 1.546E-03 1.724E-02 8.647E-03 3.216E-24
-1.00632510392520E+06 2.045E+05 4.597E+08 6.863E-01 2.557E-01 1.140E-04 1.547E-03 1.724E-02 8.647E-03 3.255E-24
-1.00633291965624E+06 2.011E+05 4.552E+08 6.863E-01 2.557E-01 1.139E-04 1.547E-03 1.724E-02 8.646E-03 3.298E-24
-1.00634087147500E+06 1.976E+05 4.505E+08 6.863E-01 2.557E-01 1.138E-04 1.548E-03 1.725E-02 8.645E-03 3.345E-24
-1.00634896565185E+06 1.942E+05 4.458E+08 6.863E-01 2.557E-01 1.138E-04 1.548E-03 1.725E-02 8.644E-03 3.383E-24
-1.00635720893825E+06 1.906E+05 4.410E+08 6.863E-01 2.557E-01 1.137E-04 1.549E-03 1.725E-02 8.642E-03 3.422E-24
-1.00636560861937E+06 1.871E+05 4.361E+08 6.863E-01 2.557E-01 1.137E-04 1.550E-03 1.725E-02 8.641E-03 3.464E-24
-1.00637417257419E+06 1.835E+05 4.311E+08 6.863E-01 2.558E-01 1.136E-04 1.550E-03 1.726E-02 8.639E-03 3.513E-24
-1.00638290934464E+06 1.799E+05 4.260E+08 6.863E-01 2.558E-01 1.136E-04 1.551E-03 1.726E-02 8.638E-03 3.552E-24
-1.00639182821525E+06 1.762E+05 4.208E+08 6.863E-01 2.558E-01 1.136E-04 1.552E-03 1.726E-02 8.636E-03 3.599E-24
-1.00640093930547E+06 1.725E+05 4.154E+08 6.863E-01 2.558E-01 1.135E-04 1.553E-03 1.727E-02 8.633E-03 3.648E-24
-1.00641025367728E+06 1.687E+05 4.100E+08 6.863E-01 2.558E-01 1.135E-04 1.553E-03 1.727E-02 8.631E-03 3.701E-24
-1.00641978346095E+06 1.649E+05 4.044E+08 6.863E-01 2.558E-01 1.135E-04 1.554E-03 1.727E-02 8.627E-03 3.755E-24
-1.00642954200324E+06 1.610E+05 3.987E+08 6.863E-01 2.558E-01 1.135E-04 1.555E-03 1.728E-02 8.623E-03 3.813E-24
-1.00643954404285E+06 1.571E+05 3.928E+08 6.863E-01 2.558E-01 1.136E-04 1.556E-03 1.728E-02 8.618E-03 3.875E-24
-1.00644980591947E+06 1.531E+05 3.868E+08 6.863E-01 2.558E-01 1.136E-04 1.557E-03 1.728E-02 8.612E-03 3.941E-24
-1.00646034582476E+06 1.491E+05 3.806E+08 6.863E-01 2.558E-01 1.136E-04 1.558E-03 1.729E-02 8.603E-03 4.010E-24
-1.00647118410579E+06 1.450E+05 3.742E+08 6.863E-01 2.558E-01 1.137E-04 1.559E-03 1.729E-02 8.593E-03 4.084E-24
-1.00648234363510E+06 1.408E+05 3.677E+08 6.863E-01 2.558E-01 1.137E-04 1.560E-03 1.729E-02 8.580E-03 4.161E-24
-1.00649385026588E+06 1.365E+05 3.609E+08 6.863E-01 2.558E-01 1.138E-04 1.561E-03 1.730E-02 8.564E-03 4.245E-24
-1.00650573339754E+06 1.322E+05 3.539E+08 6.863E-01 2.558E-01 1.138E-04 1.562E-03 1.730E-02 8.544E-03 4.336E-24
-1.00651802668610E+06 1.278E+05 3.467E+08 6.864E-01 2.558E-01 1.139E-04 1.563E-03 1.731E-02 8.521E-03 4.441E-24
-1.00653076894703E+06 1.233E+05 3.392E+08 6.864E-01 2.558E-01 1.140E-04 1.565E-03 1.731E-02 8.494E-03 4.556E-24
-1.00654400531818E+06 1.187E+05 3.314E+08 6.864E-01 2.558E-01 1.141E-04 1.566E-03 1.731E-02 8.465E-03 4.688E-24
-1.00655778877991E+06 1.140E+05 3.233E+08 6.864E-01 2.558E-01 1.142E-04 1.568E-03 1.732E-02 8.434E-03 4.835E-24
-1.00657218217557E+06 1.091E+05 3.148E+08 6.864E-01 2.559E-01 1.144E-04 1.569E-03 1.732E-02 8.404E-03 5.008E-24
-1.00658726094799E+06 1.042E+05 3.059E+08 6.864E-01 2.559E-01 1.145E-04 1.571E-03 1.732E-02 8.375E-03 5.209E-24
-1.00660311692682E+06 9.906E+04 2.966E+08 6.864E-01 2.559E-01 1.147E-04 1.573E-03 1.733E-02 8.348E-03 5.449E-24
-1.00661986370317E+06 9.379E+04 2.867E+08 6.865E-01 2.559E-01 1.149E-04 1.576E-03 1.733E-02 8.321E-03 5.746E-24
-1.00663764448239E+06 8.833E+04 2.763E+08 6.865E-01 2.559E-01 1.152E-04 1.579E-03 1.733E-02 8.293E-03 6.129E-24
-1.00665664396082E+06 8.267E+04 2.651E+08 6.865E-01 2.560E-01 1.156E-04 1.582E-03 1.733E-02 8.262E-03 6.650E-24
-1.00667710705688E+06 7.675E+04 2.532E+08 6.866E-01 2.560E-01 1.161E-04 1.587E-03 1.733E-02 8.222E-03 7.419E-24
-1.00669937001844E+06 7.054E+04 2.402E+08 6.867E-01 2.561E-01 1.169E-04 1.594E-03 1.732E-02 8.161E-03 8.703E-24
-1.00672391559321E+06 6.398E+04 2.259E+08 6.869E-01 2.563E-01 1.182E-04 1.603E-03 1.729E-02 8.066E-03 1.085E-23
-1.00675147798113E+06 5.697E+04 2.098E+08 6.878E-01 2.572E-01 1.243E-04 1.645E-03 1.711E-02 7.612E-03 2.161E-23
-1.00678327095752E+06 4.939E+04 1.917E+08 6.880E-01 2.573E-01 1.256E-04 1.646E-03 1.707E-02 7.517E-03 2.384E-23
-1.00682157793863E+06 4.099E+04 1.697E+08 6.915E-01 2.605E-01 1.473E-04 1.748E-03 1.628E-02 5.861E-03 6.216E-23
-1.00687174516882E+06 3.129E+04 1.431E+08 6.922E-01 2.610E-01 1.479E-04 1.715E-03 1.593E-02 5.690E-03 6.333E-23
-1.00695963539707E+06 1.786E+04 1.121E+08 7.169E-01 2.800E-01 2.053E-05 1.014E-04 7.765E-07 1.381E-07 7.296E-27
diff --git a/Util/initial_models/spherical/GNUmakefile b/Util/initial_models/spherical/GNUmakefile
deleted file mode 100644
index 0ca4f5d59..000000000
--- a/Util/initial_models/spherical/GNUmakefile
+++ /dev/null
@@ -1,27 +0,0 @@
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../..
-
-
-# EOS and network
-EOS_DIR := helmeos
-
-NETWORK_DIR := general_null
-GENERAL_NET_INPUTS := $(MAESTRO_TOP_DIR)/Microphysics/networks/$(NETWORK_DIR)/ignition_wdconvect.net
-
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d.f90
-
-
-include ../GInitModels.mak
-
-
diff --git a/Util/initial_models/spherical/_params b/Util/initial_models/spherical/_params
deleted file mode 100644
index 683ebea6d..000000000
--- a/Util/initial_models/spherical/_params
+++ /dev/null
@@ -1,18 +0,0 @@
-¶ms
-
- nx = 1280
- dens_base = 2.6e9
- temp_base = 6.0e8
-
- dens_conv_zone = 1.3e8
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.e8
-
- cfrac = 0.3
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_1e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_1e9_M_1.1
deleted file mode 100644
index ac7ec80c4..000000000
--- a/Util/initial_models/spherical/_params_rhoc_1e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 1.e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_1.e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_2.5e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_2.5e9_M_1.1
deleted file mode 100644
index 276744328..000000000
--- a/Util/initial_models/spherical/_params_rhoc_2.5e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 2.5e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_2.5e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_2e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_2e9_M_1.1
deleted file mode 100644
index af943ebb8..000000000
--- a/Util/initial_models/spherical/_params_rhoc_2e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 2.e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_2.e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_3.5e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_3.5e9_M_1.1
deleted file mode 100644
index 9e3e65200..000000000
--- a/Util/initial_models/spherical/_params_rhoc_3.5e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 3.5e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_3.5e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_3.5e9_M_1.1.hot b/Util/initial_models/spherical/_params_rhoc_3.5e9_M_1.1.hot
deleted file mode 100644
index 3e69211dd..000000000
--- a/Util/initial_models/spherical/_params_rhoc_3.5e9_M_1.1.hot
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 3840
- dens_base = 3.5e9
- temp_base = 6.25e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_3.5e9_M_1.1.hot"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_3e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_3e9_M_1.1
deleted file mode 100644
index 5cdcafa96..000000000
--- a/Util/initial_models/spherical/_params_rhoc_3e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 3.e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_3.e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_4.5e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_4.5e9_M_1.1
deleted file mode 100644
index b12b7f652..000000000
--- a/Util/initial_models/spherical/_params_rhoc_4.5e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 4.5e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_4.5e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_4e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_4e9_M_1.1
deleted file mode 100644
index 0ac225bcd..000000000
--- a/Util/initial_models/spherical/_params_rhoc_4e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 4.e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_4.e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/_params_rhoc_5e9_M_1.1 b/Util/initial_models/spherical/_params_rhoc_5e9_M_1.1
deleted file mode 100644
index eb6f53942..000000000
--- a/Util/initial_models/spherical/_params_rhoc_5e9_M_1.1
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
- dens_base = 5.e9
- temp_base = 6.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 1.1
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- cfrac = 0.3
-
- prefix = "WD_rhoc_5.e9_M_1.1"
-
-/
-
-
diff --git a/Util/initial_models/spherical/init_1d.f90 b/Util/initial_models/spherical/init_1d.f90
deleted file mode 100644
index 9cc414d2a..000000000
--- a/Util/initial_models/spherical/init_1d.f90
+++ /dev/null
@@ -1,482 +0,0 @@
-!! generate an initial model for spherical geometry with a
-!! uniform composition. Here we take a base density and temperature
-!! and use HSE and constant entropy to generate the model.
-
-program init_1d
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use eos_module, only: eos, eos_input_rt, eos_init
- use eos_type_module, only: eos_t
- use extern_probin_module, only: use_eos_coulomb
- use network
- use fundamental_constants_module, only: Gconst
-
- implicit none
-
- integer :: i, n
-
- integer :: nx
-
- real (kind=dp_t) :: temp_base, dens_base
- real (kind=dp_t), DIMENSION(nspec) :: xn_base
-
- real (kind=dp_t), allocatable :: xzn_hse(:), xznl(:), xznr(:)
- real (kind=dp_t), allocatable :: model_hse(:,:), M_enclosed(:)
-
- real (kind=dp_t) :: A, B, dAdT, dAdrho, dBdT, dBdrho
-
- ! define convenient indices for the scalars
- integer, parameter :: nvar = 3 + nspec
- integer, parameter :: idens = 1, &
- itemp = 2, &
- ipres = 3, &
- ispec = 4
-
- real (kind=dp_t), parameter :: M_sun = 1.9891e33
-
- ! we'll get the composition indices from the network module
- integer, save :: ic12, io16, img24, iash
- real (kind=dp_t) :: cfrac
-
- integer :: narg
- character(len=128) :: params_file
-
- real (kind=dp_t), save :: xmin, xmax, dCoord
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone, entropy
- real (kind=dp_t) :: dpd, dpt, dsd, dst
-
- real (kind=dp_t) :: p_want, drho, dtemp, delx
- real (kind=dp_t), allocatable :: entropy_store(:), entropy_want(:)
-
- real (kind=dp_t) :: g_zone
-
- real (kind=dp_t), parameter :: TOL = 1.e-10
-
- integer, parameter :: MAX_ITER = 250
-
- integer :: iter
-
- logical :: converged_hse, fluff
-
- real (kind=dp_t), dimension(nspec) :: xn
-
- real (kind=dp_t), save :: low_density_cutoff, temp_fluff, smallx, dens_conv_zone, M_conv_zone
-
- logical :: isentropic
-
- character (len=256) :: outfile, prefix
- character (len=8) num
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- integer :: i_conv, i_fluff
-
- type (eos_t) :: eos_state
-
- namelist /params/ nx, dens_base, temp_base, &
- low_density_cutoff, dens_conv_zone, M_conv_zone, temp_fluff, &
- xmin, xmax, &
- cfrac, prefix
-
-
- ! determine if we specified a runtime parameters file or use the default
- narg = command_argument_count()
-
- if (narg == 0) then
- params_file = "_params"
- else
- call get_command_argument(1, value = params_file)
- endif
-
-
- ! define the defaults parameters for this model
- nx = 1280
-
- smallx = 1.d-10
-
- xmin = 0_dp_t
- xmax = 5.d8
-
- dens_base = 2.6d9
- temp_base = 6.d8
-
- dens_conv_zone = -1.d0
- M_conv_zone = 2.0d0
-
-
- low_density_cutoff =1.d-4
- temp_fluff = 1.d7
-
- cfrac = 0.7_dp_t
-
- prefix = "spherical"
-
-
- ! check the namelist for any changed parameters
- open(unit=11, file=params_file, status="old", action="read")
- read(unit=11, nml=params)
- close(unit=11)
-
-
- ! initialize the EOS and network
-
- ! use_eos_coulomb comes in from extern_probin_module -- override
- ! here if desired
- use_eos_coulomb = .true.
- call eos_init()
- call network_init()
-
-
- ! get the species indices
- ic12 = network_species_index("carbon-12")
- io16 = network_species_index("oxygen-16")
-
- img24 = network_species_index("magnesium-24")
- iash = network_species_index("ash")
-
-
- if (ic12 < 0 .or. io16 < 0) then
- call bl_error("ERROR: species not defined")
- endif
-
- if (.not. (img24 > 0 .or. iash > 0)) then
- call bl_error("ERROR: species not defined")
- endif
-
- if (cfrac < 0.0_dp_t .or. cfrac > 1.0_dp_t) then
- call bl_error("ERROR: cfrac must be between 0 and 1")
- endif
-
- xn_base(:) = 0.0_dp_t
- xn_base(ic12) = cfrac
- xn_base(io16) = 1.0_dp_t - cfrac
-
-
-
-!-----------------------------------------------------------------------------
-! Create a 1-d uniform grid that is identical to the mesh that we are
-! mapping onto, and then we want to force it into HSE on that mesh.
-!-----------------------------------------------------------------------------
-
-! allocate storage
- allocate(xzn_hse(nx))
- allocate(xznl(nx))
- allocate(xznr(nx))
- allocate(model_hse(nx,nvar))
- allocate(M_enclosed(nx))
- allocate(entropy_want(nx))
- allocate(entropy_store(nx))
-
-! compute the coordinates of the new gridded function
- dCoord = (xmax - xmin) / dble(nx)
-
- do i = 1, nx
- xznl(i) = xmin + (dble(i) - 1.0_dp_t)*dCoord
- xznr(i) = xmin + (dble(i))*dCoord
- xzn_hse(i) = 0.5_dp_t*(xznl(i) + xznr(i))
- enddo
-
-
-
- fluff = .false.
-
-
-
- ! call the EOS one more time for this zone and then go on to the next
- eos_state%T = temp_base
- eos_state%rho = dens_base
- eos_state%xn(:) = xn_base(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- ! make the initial guess be completely uniform
- model_hse(:,idens) = eos_state%rho
- model_hse(:,itemp) = eos_state%T
- model_hse(:,ipres) = eos_state%p
-
- do i = 1, nspec
- model_hse(:,ispec-1+i) = eos_state%xn(i)
- enddo
-
- entropy_want(:) = eos_state%s
-
-
- ! keep track of the mass enclosed below the current zone
- M_enclosed(1) = FOUR3RD*M_PI*(xznr(1)**3 - xznl(1)**3)*model_hse(1,idens)
-
-
-!-----------------------------------------------------------------------------
-! HSE + entropy solve
-!-----------------------------------------------------------------------------
-
- isentropic = .true.
-
- do i = 2, nx
-
- delx = xzn_hse(i) - xzn_hse(i-1)
-
- ! as the initial guess for the temperature and density, use the previous
- ! zone
- dens_zone = model_hse(i-1,idens)
- temp_zone = model_hse(i-1,itemp)
- xn(:) = model_hse(i,ispec:nvar)
-
- g_zone = -Gconst*M_enclosed(i-1)/(xznl(i)*xznl(i))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- do iter = 1, MAX_ITER
-
- if (isentropic) then
-
- p_want = model_hse(i-1,ipres) + &
- delx*0.5_dp_t*(dens_zone + model_hse(i-1,idens))*g_zone
-
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_want(i) - entropy
-
- dAdT = -dpt
- dAdrho = 0.5d0*delx*g_zone - dpd
- dBdT = -dst
- dBdrho = -dsd
-
- dtemp = (B - (dBdrho/dAdrho)*A)/ &
- ((dBdrho/dAdrho)*dAdT - dBdT)
-
- drho = -(A + dAdT*dtemp)/dAdrho
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- ! check if the density falls below our minimum cut-off --
- ! if so, floor it
- if (dens_zone < low_density_cutoff) then
-
- i_fluff = i
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- if (dens_zone < dens_conv_zone .and. isentropic) then
-
- i_conv = i
- isentropic = .false.
-
- endif
-
-
- ! if (A < TOL .and. B < ETOL) then
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- else
-
- ! do isothermal
- p_want = model_hse(i-1,ipres) + &
- delx*0.5*(dens_zone + model_hse(i-1,idens))*g_zone
-
- temp_zone = model_hse(i-1,itemp)
-
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
-
- if (dens_zone < low_density_cutoff) then
-
- i_fluff = i
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- isentropic = .false.
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- ! update the thermodynamics in this zone
- model_hse(i,idens) = dens_zone
- model_hse(i,itemp) = temp_zone
- model_hse(i,ipres) = pres_zone
-
- print *, i, dens_zone, temp_zone
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i))* &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hse(i,idens)
-
- if (M_enclosed(i) > M_conv_zone*M_sun .and. isentropic) then
-
- i_conv = i
- isentropic = .false.
-
- endif
-
- enddo
-
-
- print *, 'mass = ', M_enclosed(nx)/M_sun
-
- write(num,'(i8)') nx
- outfile = trim(prefix) // ".hse." // trim(adjustl(num))
-
-
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nx
- write (50,1001) "# num of variables = ", nvar
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
-1000 format (1x, 12(g26.16, 1x))
-1001 format(a, i5)
-1002 format(a)
-1003 format(a,a)
-
- do i = 1, nx
-
- write (50,1000) xzn_hse(i), model_hse(i,idens), model_hse(i,itemp), model_hse(i,ipres), &
- (model_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
- dpdr = (model_hse(i,ipres) - model_hse(i-1,ipres))/delx
- rhog = HALF*(model_hse(i,idens) + model_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
-
- if (dpdr /= 0) then
- print *, i, real(model_hse(i,idens)), real(model_hse(i,itemp)), real(dpdr), real(rhog), abs(dpdr - rhog)/abs(dpdr)
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
-
- print *, 'total mass = ', M_enclosed(i_fluff)/M_sun
- print *, 'convective zone mass = ', M_enclosed(i_conv)/M_sun
-
-
-
- close (unit=50)
-
-end program init_1d
-
diff --git a/Util/initial_models/sub_chandra/GNUmakefile b/Util/initial_models/sub_chandra/GNUmakefile
deleted file mode 100644
index e86cc6a68..000000000
--- a/Util/initial_models/sub_chandra/GNUmakefile
+++ /dev/null
@@ -1,32 +0,0 @@
-# Makefile for the init_1d initial model generator
-
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../..
-
-
-# EOS and network
-EOS_DIR := helmeos
-
-NETWORK_DIR := general_null
-GENERAL_NET_INPUTS := $(MAESTRO_TOP_DIR)/Microphysics/networks/$(NETWORK_DIR)/triple_alpha_plus_o.net
-
-
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d.f90
-
-
-include ../GInitModels.mak
-
-
-
-
diff --git a/Util/initial_models/sub_chandra/README b/Util/initial_models/sub_chandra/README
deleted file mode 100644
index b9b3bb379..000000000
--- a/Util/initial_models/sub_chandra/README
+++ /dev/null
@@ -1,2 +0,0 @@
-This initial model generator is used for the SCIENCE/sub_chandra
-problem.
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.60.M_He-0.001 b/Util/initial_models/sub_chandra/_params.M_WD-0.60.M_He-0.001
deleted file mode 100644
index 58109b3a8..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.60.M_He-0.001
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 1024
-
- M_tot = 0.6
- M_He = 0.001
-
- delta = 1.d-6
-
- xmin = 0.d0
- xmax = 1.6d9
-
- temp_core = 1.d7
- temp_base = 1.d7
-
- mixed_co_wd = .true.
-
- low_density_cutoff =1.d-4
- temp_fluff = 1.d7
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.60.M_He-0.20 b/Util/initial_models/sub_chandra/_params.M_WD-0.60.M_He-0.20
deleted file mode 100644
index b77a48690..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.60.M_He-0.20
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 0.6
- M_He = 0.2
-
- delta = 1.d-6
-
- xmin = 0.d0
- xmax = 1.6d9
-
- temp_core = 1.d7
- temp_base = 4.d8
-
- mixed_co_wd = .true.
-
- low_density_cutoff =1.d-4
- temp_fluff = 1.d5
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.025.hotcutoff.hotbase b/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.025.hotcutoff.hotbase
deleted file mode 100644
index fd0012079..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.025.hotcutoff.hotbase
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 0.8
- M_He = 0.025
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 1.1e9
-
- temp_core = 1.d7
- temp_base = 2.5d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.200MK.5120 b/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.200MK.5120
deleted file mode 100644
index 7139468a4..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.200MK.5120
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 5120
-
- M_tot = 0.8
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 1.e9
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.250MK.512 b/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.250MK.512
deleted file mode 100644
index 4c0000f9a..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.250MK.512
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 5120
-
- M_tot = 0.8
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 1.e9
-
- temp_core = 1.d7
- temp_base = 2.5d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.hotbase b/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.hotbase
deleted file mode 100644
index 980cf59aa..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.05.hotcutoff.hotbase
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 0.8
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 1.e9
-
- temp_core = 1.d7
- temp_base = 2.5d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.100.hotcutoff b/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.100.hotcutoff
deleted file mode 100644
index a3d707164..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.8.M_He-0.100.hotcutoff
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 0.8
- M_He = 0.1
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 8.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-0.80.M_He-0.001 b/Util/initial_models/sub_chandra/_params.M_WD-0.80.M_He-0.001
deleted file mode 100644
index 5e7facaec..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-0.80.M_He-0.001
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 1024
-
- M_tot = 0.8
- M_He = 0.001
-
- delta = 1.d-6
-
- xmin = 0.d0
- xmax = 1.6d9
-
- temp_core = 1.d7
- temp_base = 1.d7
-
- mixed_co_wd = .true.
-
- low_density_cutoff =1.d-4
- temp_fluff = 1.d7
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.025.hotcutoff b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.025.hotcutoff
deleted file mode 100644
index 462e2c1ec..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.025.hotcutoff
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.0
- M_He = 0.025
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 7.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05 b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05
deleted file mode 100644
index f693646ef..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05
+++ /dev/null
@@ -1,22 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.0
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 7.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 1.d5
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.Tcutoff b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.Tcutoff
deleted file mode 100644
index 2a56a1c49..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.Tcutoff
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.0
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 7.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 5.d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.hotcutoff b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.hotcutoff
deleted file mode 100644
index b6f02a1d6..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.hotcutoff
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.0
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 7.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.hotcutoff.512 b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.hotcutoff.512
deleted file mode 100644
index 9655dfd22..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.05.hotcutoff.512
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 5120
-
- M_tot = 1.0
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 7.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff
deleted file mode 100644
index 2c84f23e0..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.0
- M_He = 0.1
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 6.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase
deleted file mode 100644
index c17a94b51..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.0
- M_He = 0.1
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 6.5e8
-
- temp_core = 1.d7
- temp_base = 1.5d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase.128 b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase.128
deleted file mode 100644
index de44e35f6..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase.128
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 1280
-
- M_tot = 1.0
- M_He = 0.1
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 6.5e8
-
- temp_core = 1.d7
- temp_base = 1.5d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase.512 b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase.512
deleted file mode 100644
index fb1d85fda..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.coolbase.512
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 5120
-
- M_tot = 1.0
- M_He = 0.1
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 6.5e8
-
- temp_core = 1.d7
- temp_base = 1.5d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.thin b/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.thin
deleted file mode 100644
index b05e106c7..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.0.M_He-0.1.hotcutoff.thin
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.0
- M_He = 0.1
-
- delta = 4.d6
-
- xmin = 0.d0
- xmax = 6.5e8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.1.M_He-0.05.hotcutoff.175MK b/Util/initial_models/sub_chandra/_params.M_WD-1.1.M_He-0.05.hotcutoff.175MK
deleted file mode 100644
index b039bf9ee..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.1.M_He-0.05.hotcutoff.175MK
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.1
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 6.d8
-
- temp_core = 1.d7
- temp_base = 1.75d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.025.hotcutoff.175MK.5120 b/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.025.hotcutoff.175MK.5120
deleted file mode 100644
index d38bff788..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.025.hotcutoff.175MK.5120
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 5120
-
- M_tot = 1.2
- M_He = 0.025
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 5.d8
-
- temp_core = 1.d7
- temp_base = 1.75d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff b/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff
deleted file mode 100644
index d536ad602..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.2
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 5.d8
-
- temp_core = 1.d7
- temp_base = 2.d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase b/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase
deleted file mode 100644
index 711cbab6d..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 2560
-
- M_tot = 1.2
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 5.d8
-
- temp_core = 1.d7
- temp_base = 1.5d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase.3840 b/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase.3840
deleted file mode 100644
index 6d0834f86..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase.3840
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 3840
-
- M_tot = 1.2
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 5.d8
-
- temp_core = 1.d7
- temp_base = 1.75d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase.5120 b/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase.5120
deleted file mode 100644
index eed60537e..000000000
--- a/Util/initial_models/sub_chandra/_params.M_WD-1.2.M_He-0.05.hotcutoff.coolbase.5120
+++ /dev/null
@@ -1,23 +0,0 @@
-¶ms
-
- nx = 5120
-
- M_tot = 1.2
- M_He = 0.05
-
- delta = 5.d6
-
- xmin = 0.d0
- xmax = 5.d8
-
- temp_core = 1.d7
- temp_base = 1.75d8
-
- mixed_co_wd = .false.
-
- low_density_cutoff =1.d-4
- temp_fluff = 7.5d7
- smallt = 1.d6
-
-/
-
diff --git a/Util/initial_models/sub_chandra/init_1d.f90 b/Util/initial_models/sub_chandra/init_1d.f90
deleted file mode 100755
index 17aef7d2b..000000000
--- a/Util/initial_models/sub_chandra/init_1d.f90
+++ /dev/null
@@ -1,665 +0,0 @@
-!! generate an initial model for an arbitrary-mass, isothermal C WD
-!! with an isentropic He envelope on the surface.
-
-program init_1d
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use extern_probin_module, only: use_eos_coulomb
- use eos_module, only: eos_input_rt, eos, eos_init
- use eos_type_module, only: eos_t
- use network
- use fundamental_constants_module, only: Gconst
- use f2kcli
-
- implicit none
-
- integer :: i, n
-
- character(len=128) :: params_file
-
- real (kind=dp_t) :: temp_core, temp_base, delta
- real (kind=dp_t), DIMENSION(nspec) :: xn_core, xn_he
-
- logical :: mixed_co_wd
-
- real (kind=dp_t), allocatable :: xzn_hse(:), xznl(:), xznr(:)
- real (kind=dp_t), allocatable :: model_hse(:,:), M_enclosed(:)
- real (kind=dp_t), allocatable :: cs_hse(:), s_hse(:)
-
- real (kind=dp_t) :: rho_c, rho_c_old, mass_wd, mass_wd_old, drho_c
- real (kind=dp_t) :: rho_he, rho_he_old, mass_he, mass_he_old, drho_he
-
- real (kind=dp_t) :: slope_T, slope_xn(nspec)
-
- real (kind=dp_t) :: A, B, dAdT, dAdrho, dBdT, dBdrho
- logical :: isentropic
-
- real (kind=dp_t) :: test
-
- integer :: nx
-
- ! define convenient indices for the scalars
- integer, parameter :: nvar = 3 + nspec
- integer, parameter :: idens = 1, &
- itemp = 2, &
- ipres = 3, &
- ispec = 4
-
- ! we'll get the composition indices from the network module
- integer, save :: ihe4, ic12, io16
-
- real (kind=dp_t), save :: xmin, xmax, dCoord
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone, entropy
- real (kind=dp_t) :: dpd, dpt, dsd, dst
-
- real (kind=dp_t) :: p_want, drho, dtemp, delx
- real (kind=dp_t) :: entropy_base
-
- real (kind=dp_t) :: g_zone
-
- ! TOL_HSE is the tolerance used when iterating over a zone to force
- ! it into HSE by adjusting the current density (and possibly
- ! temperature). TOL_HSE should be very small (~ 1.e-10).
- real (kind=dp_t), parameter :: TOL_HSE = 1.d-10
-
- ! TOL_WD_MASS is tolerance used for getting the total WD mass equal
- ! to M_tot (defined below). It can be reasonably small, since there
- ! will always be a central density value that can give the desired
- ! WD mass on the grid we use
- real (kind=dp_t), parameter :: TOL_WD_MASS = 1.d-4
-
- ! TOL_HE_MASS is the tolerance used for getting the mass of the He
- ! envelope. This should not be too small, since the values of the
- ! He envelope mass we can achieve will depend on our grid spacing.
- real (kind=dp_t), parameter :: TOL_HE_MASS = 2.d-2
-
-
- integer, parameter :: MAX_ITER = 250
-
- integer :: iter, iter_mass
-
- integer :: icutoff, ihe_layer, ihe_entropy
-
- logical :: converged_hse, fluff, mass_converged
-
- real (kind=dp_t), dimension(nspec) :: xn
-
- real (kind=dp_t) :: low_density_cutoff, temp_fluff, smallx, smallt
-
- real (kind=dp_t) :: M_tot, M_He
- real (kind=dp_t) :: solar_mass = 1.98892d33
-
- character (len=256) :: outfile
- character (len=8) num, mass_wd_str, mass_he_str
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- integer :: narg
-
- type (eos_t) :: eos_state
-
- namelist /params/ nx, M_tot, M_He, delta, xmin, xmax, &
- temp_core, temp_base, mixed_co_wd, low_density_cutoff, temp_fluff, smallt
-
-
- ! determine if we specified a runtime parameters file or use the default
- narg = command_argument_count()
-
- if (narg == 0) then
- params_file = "_params"
- else
- call get_command_argument(1, value = params_file)
- endif
-
-
-
- ! define the defaults parameters for this model
- nx = 2560
-
- M_tot = 0.6
- M_He = 0.2
-
- delta = 1.d-6
-
- xmin = 0_dp_t
- xmax = 1.6e9_dp_t
-
- temp_core = 1.d7
- temp_base = 4.d8
-
- mixed_co_wd = .true.
-
- low_density_cutoff =1.d-4
- temp_fluff = 1.d5
- smallt = 1.d5
-
- ! check the namelist for any changed parameters
- open(unit=11, file=trim(params_file), status="old", action="read")
- read(unit=11, nml=params)
- close(unit=11)
-
-
- ! convert the envelope and WD mass into solar masses
- M_tot = M_tot * solar_mass
- M_He = M_He * solar_mass
-
-
- ! this comes in via extern_probin_module, override the default if desired.
- use_eos_coulomb = .true.
-
- smallx = 1.d-10
-
-
- ! initialize the EOS and network
- call eos_init()
- call network_init()
-
-
- ! get the species indices
- ihe4 = network_species_index("helium-4")
- ic12 = network_species_index("carbon-12")
- io16 = network_species_index("oxygen-16")
-
- if (ihe4 < 0 .or. ic12 < 0 .or. io16 < 0) then
- call bl_error("ERROR: species not defined")
- endif
-
- if (mixed_co_wd) then
- xn_core(:) = smallx
- xn_core(ic12) = 0.5_dp_t - 0.5*(nspec - 1)*smallx
- xn_core(io16) = 0.5_dp_t - 0.5*(nspec - 1)*smallx
- else
- xn_core(:) = smallx
- xn_core(ic12) = 1.0_dp_t - (nspec - 1)*smallx
- endif
-
-
- xn_he(:) = smallx
- xn_he(ihe4) = 1.0_dp_t - (nspec - 1)*smallx
-
-
- !----------------------------------------------------------------------------
- ! Create a 1-d uniform grid that is identical to the mesh that we are
- ! mapping onto, and then we want to force it into HSE on that mesh.
- !----------------------------------------------------------------------------
-
- ! allocate storage
- allocate(xzn_hse(nx))
- allocate(xznl(nx))
- allocate(xznr(nx))
- allocate(model_hse(nx,nvar))
- allocate(M_enclosed(nx))
- allocate(cs_hse(nx))
- allocate(s_hse(nx))
-
- ! compute the coordinates of the new gridded function
- dCoord = (xmax - xmin) / dble(nx)
-
- do i = 1, nx
- xznl(i) = xmin + (dble(i) - 1.0_dp_t)*dCoord
- xznr(i) = xmin + (dble(i))*dCoord
- xzn_hse(i) = 0.5_dp_t*(xznl(i) + xznr(i))
- enddo
-
-
- ! We don't know what WD central density will give the desired total
- ! mass, so we need to iterate over central density
-
- ! we will do a secant iteration. rho_c_old is the 'old' guess for
- ! the central density and rho_c is the current guess. After 2
- ! loops, we can start estimating the density required to yield our
- ! desired mass
- rho_c_old = -1.0_dp_t
- rho_c = 1.e9_dp_t ! 1.e9 is a reasonable starting WD central density
-
- ! rho_he_old is the old guess for the density to transition to He,
- ! where we will be isentropic, and rho_he is the currrent guess.
- rho_he_old = -1.0_dp_t
- rho_he = 0.5*rho_c
-
- mass_converged = .false.
-
-
- do iter_mass = 1, MAX_ITER
-
- print *, 'mass iter = ', iter_mass, rho_c, temp_core
-
- fluff = .false.
-
- ! we start at the center of the WD and integrate outward. Initialize
- ! the central conditions.
- eos_state%T = temp_core
- eos_state%rho = rho_c
- eos_state%xn(:) = xn_core(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- ! make the initial guess be completely uniform
- model_hse(:,idens) = eos_state%rho
- model_hse(:,itemp) = eos_state%T
- model_hse(:,ipres) = eos_state%p
-
- do i = 1, nspec
- model_hse(:,ispec-1+i) = eos_state%xn(i)
- enddo
-
-
- ! keep track of the mass enclosed below the current zone
- M_enclosed(1) = FOUR3RD*M_PI*(xznr(1)**3 - xznl(1)**3)*model_hse(1,idens)
-
- ihe_layer = -1
- ihe_entropy = -1
-
- !-------------------------------------------------------------------------
- ! HSE + entropy solve
- !-------------------------------------------------------------------------
- do i = 2, nx
-
- delx = xzn_hse(i) - xzn_hse(i-1)
-
- ! as the initial guess for the density, use the previous zone
- dens_zone = model_hse(i-1,idens)
-
- if (dens_zone > rho_he) then
- temp_zone = temp_core
- xn(:) = xn_core(:)
-
- isentropic = .false.
-
- else
-
- if (ihe_layer == -1) then
- ihe_layer = i
- endif
-
- ! determine whether we are starting the ramp up. We will
- ! use a tanh profile, centered at (xzn_hse(ihe_layer) +
- ! FOUR*delta). The "+ FOUR*delta" enables us to capture
- ! the leading edge of the profile. Since rho_he is
- ! computed by considering the integral of He on the grid,
- ! shifting the profile by FOUR*delta doesn't affect the
- ! overall mass.
-
- test = HALF*(ONE + tanh((xzn_hse(i) - xzn_hse(ihe_layer) - FOUR*delta)/delta))
-
- if (test < 0.999d0) then
-
- ! small tanh ramp up regime
- xn(:) = xn_core(:) + HALF*(xn_he(:) - xn_core(:))* &
- (ONE + tanh((xzn_hse(i) - xzn_hse(ihe_layer) - FOUR*delta)/delta))
-
- temp_zone = temp_core + HALF*(temp_base - temp_core)* &
- (ONE + tanh((xzn_hse(i) - xzn_hse(ihe_layer) - FOUR*delta)/delta))
-
- isentropic = .false.
-
- else
-
- ! fully isentropic
- if (ihe_entropy == -1) then
- ihe_entropy = i
- temp_zone = temp_base
- isentropic = .false.
- else
- temp_zone = model_hse(i-1,itemp)
- isentropic = .true.
- endif
-
- xn(:) = xn_he(:)
-
- endif
-
- endif
-
- g_zone = -Gconst*M_enclosed(i-1)/(xznl(i)*xznl(i))
-
-
- !----------------------------------------------------------------------
- ! iteration loop
- !----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- do iter = 1, MAX_ITER
-
-
- if (isentropic) then
-
- p_want = model_hse(i-1,ipres) + &
- delx*0.5_dp_t*(dens_zone + model_hse(i-1,idens))*g_zone
-
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_base - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_base - entropy
-
- dAdT = -dpt
- dAdrho = 0.5d0*delx*g_zone - dpd
- dBdT = -dst
- dBdrho = -dsd
-
- dtemp = (B - (dBdrho/dAdrho)*A)/ &
- ((dBdrho/dAdrho)*dAdT - dBdT)
-
- drho = -(A + dAdT*dtemp)/dAdrho
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
- ! check if the density falls below our minimum
- ! cut-off -- if so, floor it
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- if ( abs(drho) < TOL_HSE*dens_zone .and. &
- abs(dtemp) < TOL_HSE*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- else
- ! the core is isothermal, so we just need to constrain
- ! the density and pressure to agree with the EOS and HSE
-
- ! We difference HSE about the interface between the current
- ! zone and the one just inside.
- p_want = model_hse(i-1,ipres) + &
- delx*0.5*(dens_zone + model_hse(i-1,idens))*g_zone
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (abs(drho) < TOL_HSE*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
-
- icutoff = i
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
- endif
-
- if (temp_zone < temp_fluff .and. isentropic) then
- temp_zone = temp_fluff
- isentropic = .false.
- endif
-
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
- ! call the EOS one more time for this zone and then go on
- ! to the next
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! determine the entropy that we want to constrain to, if
- ! this is the first zone of the He layer
- if (i == ihe_entropy) then
- entropy_base = entropy
- endif
-
-
- ! update the thermodynamics in this zone
- model_hse(i,idens) = dens_zone
- model_hse(i,itemp) = temp_zone
- model_hse(i,ipres) = pres_zone
-
- model_hse(i,ispec:ispec-1+nspec) = xn(:)
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i))* &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hse(i,idens)
-
- cs_hse(i) = eos_state%cs
- s_hse(i) = eos_state%s
-
- enddo ! end loop over zones
-
-
- ! compute the total mass of the He layer and C/O WD
- mass_he = FOUR3RD*M_PI*(xznr(1)**3 - xznl(1)**3)* &
- model_hse(1,idens)*model_hse(1,ispec-1+ihe4)
-
- mass_wd = FOUR3RD*M_PI*(xznr(1)**3 - xznl(1)**3)*model_hse(1,idens)* &
- (model_hse(1,ispec-1+ic12) + model_hse(1,ispec-1+io16))
-
- do i = 2, icutoff
- mass_he = mass_he + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i))* &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hse(i,idens)* &
- model_hse(i,ispec-1+ihe4)
-
- mass_wd = mass_wd + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i))* &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hse(i,idens)* &
- (model_hse(i,ispec-1+ic12) + model_hse(i,ispec-1+io16))
- enddo
-
-
- if (rho_c_old < 0.0_dp_t) then
- ! not enough iterations yet -- store the old central density and
- ! mass and pick a new value
- rho_c_old = rho_c
- mass_wd_old = mass_wd
-
- rho_he_old = rho_he
- mass_he_old = mass_he
-
- rho_c = 0.5*rho_c_old
- rho_he = 0.5*rho_he_old
-
- else
- ! have we converged
- if ( abs(mass_wd - M_tot)/M_tot < TOL_WD_MASS .and. &
- abs(mass_he - M_He)/M_He < TOL_HE_MASS) then
- mass_converged = .true.
- exit
- endif
-
- ! do a secant iteration:
- ! M_tot = M(rho_c) + dM/drho |_rho_c x drho + ...
- drho_c = (M_tot - mass_wd)/ &
- ( (mass_wd - mass_wd_old)/(rho_c - rho_c_old) )
-
- rho_c_old = rho_c
- mass_wd_old = mass_wd
-
- rho_c = min(1.1_dp_t*rho_c_old, &
- max((rho_c + drho_c), 0.9_dp_t*rho_c_old))
-
-
- drho_he = (M_He - mass_he)/ &
- ( (mass_he - mass_he_old)/(rho_he - rho_he_old) )
-
- rho_he_old = rho_he
- mass_he_old = mass_he
-
- rho_he = min(1.1_dp_t*rho_he_old, &
- max((rho_he + drho_he), 0.9_dp_t*rho_he_old))
-
- print *, 'current mass = ', mass_wd/solar_mass, mass_he/solar_mass
-
- endif
-
- enddo ! end mass constraint loop
-
- if (.not. mass_converged) then
- print *, 'ERROR: WD mass did not converge'
- call bl_error("ERROR: mass did not converge")
- endif
-
- print *, 'final masses: '
- print *, ' mass WD: ', mass_wd/solar_mass
- print *, ' mass He: ', mass_He/solar_mass
- print *, ihe_layer
-
-
- ! store the model
- write(num,'(i8)') nx
- write(mass_wd_str,'(f4.2)') mass_wd/solar_mass
- write(mass_he_str,'(f5.3)') mass_He/solar_mass
- !if (mass_He/solar_mass > 0.01) then
- ! write(mass_he_str,'(f4.2)') mass_He/solar_mass
- !else
- ! write(mass_he_str,'(f6.4)') mass_He/solar_mass
- !endif
-
- if (mixed_co_wd) then
- outfile = "sub_chandra.M_WD-" // trim(adjustl(mass_wd_str)) // &
- ".M_He-" // trim(adjustl(mass_he_str)) // &
- ".hse.CO." // trim(adjustl(num))
- else
- outfile = "sub_chandra.M_WD-" // trim(adjustl(mass_wd_str)) // &
- ".M_He-" // trim(adjustl(mass_he_str)) // &
- ".hse.C." // trim(adjustl(num))
- endif
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nx
- write (50,1001) "# num of variables = ", nvar
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
-1000 format (1x, 12(g26.16, 1x))
-1001 format(a, i5)
-1002 format(a)
-1003 format(a,a)
-
- do i = 1, nx
- write (50,1000) xzn_hse(i), model_hse(i,idens), model_hse(i,itemp), model_hse(i,ipres), &
- (model_hse(i,ispec-1+n), n=1,nspec)
- enddo
-
- close (50)
-
-
- ! extra info
- if (mixed_co_wd) then
- outfile = "sub_chandra.M_WD-" // trim(adjustl(mass_wd_str)) // &
- ".M_He-" // trim(adjustl(mass_he_str)) // &
- ".extras.CO." // trim(adjustl(num))
- else
- outfile = "sub_chandra.M_WD-" // trim(adjustl(mass_wd_str)) // &
- ".M_He-" // trim(adjustl(mass_he_str)) // &
- ".extras.C." // trim(adjustl(num))
- endif
-
- open (unit=51, file=outfile, status="unknown")
-
- write (51,1001) "# npts = ", nx
- write (51,1002) "# cs"
- write (51,1002) "# entropy"
-
- do i = 1, nx
- write (51,1000) xzn_hse(i), cs_hse(i), s_hse(i)
- enddo
-
- close (51)
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
- dpdr = (model_hse(i,ipres) - model_hse(i-1,ipres))/delx
- rhog = HALF*(model_hse(i,idens) + model_hse(i-1,idens))*g_zone
-
- print *, xzn_hse(i), g_zone*xzn_hse(i)
-
- if (dpdr /= ZERO .and. model_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
-
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
-end program init_1d
-
diff --git a/Util/initial_models/test2/GNUmakefile b/Util/initial_models/test2/GNUmakefile
deleted file mode 100644
index b741d4847..000000000
--- a/Util/initial_models/test2/GNUmakefile
+++ /dev/null
@@ -1,25 +0,0 @@
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR := ../../..
-
-# EOS and network
-EOS_DIR := helmeos
-
-NETWORK_DIR := general_null
-GENERAL_NET_INPUTS := $(MAESTRO_TOP_DIR)/Microphysics/networks/$(NETWORK_DIR)/ignition.net
-
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d.f90
-
-
-include ../GInitModels.mak
-
-
diff --git a/Util/initial_models/test2/README b/Util/initial_models/test2/README
deleted file mode 100644
index 6dfed2e26..000000000
--- a/Util/initial_models/test2/README
+++ /dev/null
@@ -1,3 +0,0 @@
-note: this is a standalone procedure from the FLASH lmn_bubble_burn
-setup that was written for paper III. This can be used for both test2
-and test_convect.
diff --git a/Util/initial_models/test2/_params.orig_test_convect b/Util/initial_models/test2/_params.orig_test_convect
deleted file mode 100644
index a88664ed8..000000000
--- a/Util/initial_models/test2/_params.orig_test_convect
+++ /dev/null
@@ -1,25 +0,0 @@
-¶ms
-
- ! this set of parameters appears to reproduce the original initial
- ! model in test_convect, which was used in paper III. Note: Coulomb
- ! corrections we off back then.
-
- do_coulomb = .false.
-
- xmin = 0.0d0
- xmax = 3.6d8
-
- base_height = 1.d8
-
- entropy_jump = 3.d0
- entropy_end = 6.d0
-
- dens_base = 2.6d9
- temp_base = 7.d8
-
- g_zone = -1.5d10
-
- low_density_cutoff = 1.d-4
- temp_fluff = 1.d7
-
-/
diff --git a/Util/initial_models/test2/_params.test2 b/Util/initial_models/test2/_params.test2
deleted file mode 100644
index 1fdb9d49b..000000000
--- a/Util/initial_models/test2/_params.test2
+++ /dev/null
@@ -1,26 +0,0 @@
-¶ms
-
- ! this set of parameters appears to reproduce the
- ! model.hse.cool.coulomb in test2.
-
- nx = 640
-
- do_coulomb = .true.
-
- xmin = 0.0d0
- xmax = 3.6d8
-
- base_height = 5.d7
-
- entropy_jump = 3.d0
- entropy_end = 4.d0
-
- dens_base = 2.6d9
- temp_base = 6.d8
-
- g_zone = -1.5d10
-
- low_density_cutoff = 1.d-4
- temp_fluff = 1.d7
-
-/
diff --git a/Util/initial_models/test2/init_1d.f90 b/Util/initial_models/test2/init_1d.f90
deleted file mode 100755
index dbfbea656..000000000
--- a/Util/initial_models/test2/init_1d.f90
+++ /dev/null
@@ -1,614 +0,0 @@
-!! Create a 1-d hydrostatic, isoentropic atmosphere given the temperature,
-!! composition, and base density. This version allows for an entropy
-!! decrease below a height base_height, to make the lower region
-!! convectively stable.
-!!
-!! The model is placed into HSE by the following differencing:
-!!
-!! (1/dr) [ _i -
_{i-1} ] = (1/2) [ _i + _{i-1} ] g
-!!
-!! We can take _base and _base as given, and use the above
-!! to find all others.
-!!
-!! This will be iterated over in tandem with the EOS call,
-!! P(i-1) = P_eos(rho(i-1), T(i-1), X(i-1)
-!!
-
-program init_1d
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use eos_module, only: eos_input_rt, eos, eos_init
- use eos_type_module, only: eos_t
- use extern_probin_module, only: use_eos_coulomb
- use network, only : nspec, network_species_index, spec_names, network_init
-
- implicit none
-
- integer :: i, n
-
- character(len=128) :: params_file
-
- real (kind=dp_t) :: temp_base, dens_base
- real (kind=dp_t), DIMENSION(nspec) :: xn_base
-
- real (kind=dp_t), allocatable :: xzn_hse(:)
- real (kind=dp_t), allocatable :: model_hse(:,:)
-
- real :: A, B
-
- integer :: nx
-
- ! define convenient indices for the scalars
- integer, parameter :: nvar = 3 + nspec
- integer, parameter :: idens = 1, &
- itemp = 2, &
- ipres = 3, &
- ispec = 4
-
- ! we'll get the composition from the network module
- integer :: ic12, io16, iash
-
- real (kind=dp_t) :: xmin, xmax, dCoord
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone, entropy
- real (kind=dp_t) :: dpd, dpt, dsd, dst
-
- real (kind=dp_t) :: p_want, drho, dtemp, delx
- real (kind=dp_t), allocatable :: entropy_store(:), entropy_want(:)
-
- real (kind=dp_t) :: g_zone
-
- real (kind=dp_t), parameter :: TOL = 1.e-10
-
- integer, parameter :: MAX_ITER = 250
-
- integer :: iter
-
- logical :: converged_hse, fluff
-
- real (kind=dp_t), dimension(nspec) :: xn
-
- real (kind=dp_t) :: low_density_cutoff, temp_fluff, smallx
-
- real (kind=dp_t) :: entropy_jump, entropy_end, base_height
-
- logical :: do_coulomb
-
- integer :: index_base
-
- real (kind=dp_t) :: slope
-
- logical :: isentropic
-
- character (len=256) :: outfile
- character (len=8) :: num
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- integer :: narg
-
- type (eos_t) :: eos_state
-
- namelist /params/ nx, xmin, xmax, base_height, entropy_jump, entropy_end, &
- dens_base, temp_base, g_zone, low_density_cutoff, temp_fluff, do_coulomb
-
- ! determine if we specified a runtime parameters file or use the
- ! default
- narg = command_argument_count()
-
- if (narg == 0) then
- params_file = "_params"
- else
- call get_command_argument(1, value = params_file)
- endif
-
-
- ! define the defaults parameters for this model
- nx = 640
-
- xmin = 0_dp_t
- xmax = 3.6d8
-
- base_height = 1.d8
-
- entropy_jump = 3.d0
- entropy_end = 6.d0
-
- dens_base = 2.6d9
- temp_base = 7.d8
-
- g_zone = -1.5d10
-
- low_density_cutoff = 1.d-4
- temp_fluff = 1.d7
-
-
- ! check the namelist for any changed parameters
- open(unit=11, file=trim(params_file), status="old", action="read")
- read(unit=11, nml=params)
- close(unit=11)
-
-
-
-
- ! EOS stuff
- smallx = 1.d-10
-
- ! this comes in from extern_probin_module -- override here if desired
- use_eos_coulomb = do_coulomb
-
-
- ! initialize the EOS and network
- call eos_init()
- call network_init()
-
-
- ! get the species indices
- ic12 = network_species_index("carbon-12")
- io16 = network_species_index("oxygen-16")
-
- ! ash can be either Mg24 or 'ash', depending on the network
- iash = network_species_index("magnesium-24")
- if (iash < 0) then
- iash = network_species_index("ash")
- endif
-
- if (ic12 < 0 .or. io16 < 0 .or. iash < 0) then
- call bl_error("ERROR: species not defined")
- endif
-
- xn_base(ic12) = 0.3_dp_t
- xn_base(io16) = 0.7_dp_t
- xn_base(iash) = 0.0_dp_t
-
-
-!-----------------------------------------------------------------------------
-! Create a 1-d uniform grid that is identical to the mesh that we are
-! mapping onto, and then we want to force it into HSE on that mesh.
-!-----------------------------------------------------------------------------
-
-! allocate storage
- allocate(xzn_hse(nx))
- allocate(model_hse(nx,nvar))
- allocate(entropy_want(nx))
- allocate(entropy_store(nx))
-
-! compute the coordinates of the new gridded function
- dCoord = (xmax - xmin) / dble(nx)
-
- do i = 1, nx
- xzn_hse(i) = xmin + (dble(i) - 0.5_dp_t)*dCoord
- enddo
-
-
- index_base = -1
-
-! find the index of the base height
- do i = 1, nx
- if (xzn_hse(i) >= base_height) then
- index_base = i
- exit
- endif
- enddo
-
- if (index_base == -1) then
- print *, 'ERROR: base_height not found on grid'
- call bl_error('ERROR: invalid base_height')
- endif
-
-
-
-!-----------------------------------------------------------------------------
-! put the model onto our new uniform grid
-!-----------------------------------------------------------------------------
-
- fluff = .false.
-
- ! all the material above base_height will have constant entropy
- eos_state%T = temp_base
- eos_state%rho = dens_base
- eos_state%xn(:) = xn_base(:)
-
- print *, eos_state%T, eos_state%rho, eos_state%xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- ! make the inital guess be completely uniform
- model_hse(:,idens) = eos_state%rho
- model_hse(:,itemp) = eos_state%T
- model_hse(:,ipres) = eos_state%p
-
- do i = 1, nspec
- model_hse(:,ispec-1+i) = eos_state%xn(i)
- enddo
-
- entropy = eos_state%s
-
- ! set the desired entropy profile
- do i = index_base, nx
-
- ! entropy is constant
- entropy_want(i) = entropy
- entropy_store(i) = entropy_want(i)
- enddo
-
-
- slope = (entropy/entropy_jump - entropy/entropy_end)/ &
- (xzn_hse(index_base) - xzn_hse(1))
-
- do i = index_base-1, 1, -1
-
- ! entropy gradient
- entropy_want(i) = slope*(xzn_hse(i) - xzn_hse(index_base-1)) + entropy/entropy_jump
- entropy_store(i) = entropy_want(i)
- enddo
-
-
-!-----------------------------------------------------------------------------
-! HSE + entropy solve
-!-----------------------------------------------------------------------------
-
-! the HSE state will be done putting creating an isentropic state until
-! the temperature goes below temp_fluff -- then we will do isothermal.
-! also, once the density goes below low_density_cutoff, we stop HSE
-
- isentropic = .true.
-
- !---------------------------------------------------------------------------
- ! integrate up
- !---------------------------------------------------------------------------
- do i = index_base+1, nx
-
- delx = xzn_hse(i) - xzn_hse(i-1)
-
- ! as the initial guess for the temperature and density, use the previous
- ! zone
- dens_zone = model_hse(i-1,idens)
- temp_zone = model_hse(i-1,itemp)
- xn(:) = model_hse(i,ispec:nvar)
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- do iter = 1, MAX_ITER
-
- if (isentropic) then
-
- ! get the pressure we want from the HSE equation, just the
- ! zone below the current. Note, we are using an average of
- ! the density of the two zones as an approximation of the
- ! interface value -- this means that we need to iterate for
- ! find the density and pressure that are consistent
-
- ! furthermore, we need to get the entropy that we need,
- ! which will come from adjusting the temperature in
- ! addition to the density.
-
- ! HSE differencing
- p_want = model_hse(i-1,ipres) + &
- delx*0.5*(dens_zone + model_hse(i-1,idens))*g_zone
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
-
- ! now we know the pressure and the entropy that we want, so we
- ! need to find the temperature and density through a two
- ! dimensional root find
-
- ! (t, rho) -> (p, s)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_want(i) - entropy
-
- dtemp = ((dsd/(dpd-0.5*delx*g_zone))*A - B)/ &
- (dsd*dpt/(dpd -0.5*delx*g_zone) - dst)
-
- drho = (A - dpt*dtemp)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- ! check if the density falls below our minimum cut-off --
- ! if so, floor it
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- ! if (A < TOL .and. B < ETOL) then
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- else
-
- ! do isothermal
- p_want = model_hse(i-1,ipres) + &
- delx*0.5*(dens_zone + model_hse(i-1,idens))*g_zone
-
- temp_zone = temp_fluff
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want, entropy_want(i), entropy
- print *, drho, dtemp
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- if (temp_zone < temp_fluff) then
- temp_zone = temp_fluff
- isentropic = .false.
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = temp_fluff
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! update the thermodynamics in this zone
- model_hse(i,idens) = dens_zone
- model_hse(i,itemp) = temp_zone
- model_hse(i,ipres) = pres_zone
- entropy_store(i) = entropy
-
- ! to make this process converge faster, set the density in the next zone to
- ! the density in this zone
- ! model_hse(i+1,idens) = dens_zone
-
- enddo
-
-
- !---------------------------------------------------------------------------
- ! integrate down
- !---------------------------------------------------------------------------
- do i = index_base-1, 1, -1
-
- delx = xzn_hse(i+1) - xzn_hse(i)
-
- ! as the initial guess for the temperature and density, use the previous
- ! zone
- dens_zone = model_hse(i+1,idens)
- temp_zone = model_hse(i+1,itemp)
- xn(:) = model_hse(i,ispec:nvar)
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- do iter = 1, MAX_ITER
-
- ! get the pressure we want from the HSE equation, just the
- ! zone below the current. Note, we are using an average of
- ! the density of the two zones as an approximation of the
- ! interface value -- this means that we need to iterate for
- ! find the density and pressure that are consistent
-
- ! furthermore, we need to get the entropy that we need,
- ! which will come from adjusting the temperature in
- ! addition to the density.
-
- ! HSE differencing
- p_want = model_hse(i+1,ipres) - &
- delx*0.5*(dens_zone + model_hse(i+1,idens))*g_zone
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
-
- ! now we know the pressure and the entropy that we want, so we
- ! need to find the temperature and density through a two
- ! dimensional root find
- ! (t, rho) -> (p, s)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_want(i) - entropy
-
- dtemp = ((dsd/(dpd+0.5*delx*g_zone))*A - B)/ &
- (dsd*dpt/(dpd +0.5*delx*g_zone) - dst)
-
- drho = (A - dpt*dtemp)/(dpd + 0.5*delx*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate down'
- print *, dens_zone, temp_zone
- print *, p_want, entropy_want(i), entropy
- print *, drho, dtemp
- call bl_error('Error: HSE non-convergence')
-
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! update the thermodynamics in this zone
- model_hse(i,idens) = dens_zone
- model_hse(i,itemp) = temp_zone
- model_hse(i,ipres) = pres_zone
- entropy_store(i) = entropy
-
-
- enddo
-
- write(num,'(i8)') nx
- outfile = "model.hse." // trim(adjustl(num))
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nx
- write (50,1001) "# num of variables = ", nvar
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50, 1003) "# ", spec_names(n)
- enddo
-
-1000 format (1x, 12(g26.16, 1x))
-1001 format (a, i5)
-1002 format (a)
-1003 format (a,a)
-
- do i = 1, nx
-
- write (50,1000) xzn_hse(i), model_hse(i,idens), model_hse(i,itemp), model_hse(i,ipres), &
- (model_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
- dpdr = (model_hse(i,ipres) - model_hse(i-1,ipres))/delx
- rhog = HALF*(model_hse(i,idens) + model_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
- close (unit=50)
-
-end program init_1d
-
-
-
-
-
-
diff --git a/Util/initial_models/toy_atm/GNUmakefile b/Util/initial_models/toy_atm/GNUmakefile
deleted file mode 100644
index 985efb23e..000000000
--- a/Util/initial_models/toy_atm/GNUmakefile
+++ /dev/null
@@ -1,32 +0,0 @@
-# Makefile for the init_1d initial model generator
-
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../..
-
-
-# EOS and network
-EOS_DIR := helmeos
-
-NETWORK_DIR := general_null
-GENERAL_NET_INPUTS := $(MAESTRO_TOP_DIR)/Microphysics/networks/$(NETWORK_DIR)/triple_alpha_plus_o.net
-
-
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d_tanh2.f90
-
-
-include ../GInitModels.mak
-
-
-
-
diff --git a/Util/initial_models/toy_atm/GNUmakefile.convective_flame b/Util/initial_models/toy_atm/GNUmakefile.convective_flame
deleted file mode 100644
index 15f3b65c4..000000000
--- a/Util/initial_models/toy_atm/GNUmakefile.convective_flame
+++ /dev/null
@@ -1,30 +0,0 @@
-# Makefile for the init_1d initial model generator
-
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../..
-
-
-# EOS and network
-EOS_DIR := gamma_law_general
-
-NETWORK_DIR := general_null
-GENERAL_NET_INPUTS := $(MAESTRO_TOP_DIR)/Microphysics/networks/$(NETWORK_DIR)/powerlaw.net
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d_tanh2.f90
-
-
-include ../GInitModels.mak
-
-
-
-
diff --git a/Util/initial_models/toy_atm/GNUmakefile.flame_wave b/Util/initial_models/toy_atm/GNUmakefile.flame_wave
deleted file mode 100644
index 83f920474..000000000
--- a/Util/initial_models/toy_atm/GNUmakefile.flame_wave
+++ /dev/null
@@ -1,29 +0,0 @@
-# Makefile for the init_1d initial model generator
-
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../..
-
-
-# EOS and network
-EOS_DIR := helmeos
-
-NETWORK_DIR := triple_alpha_plus_cago
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d_tanh2.f90
-
-
-include ../GInitModels.mak
-
-
-
-
diff --git a/Util/initial_models/toy_atm/README b/Util/initial_models/toy_atm/README
deleted file mode 100644
index 00eecac04..000000000
--- a/Util/initial_models/toy_atm/README
+++ /dev/null
@@ -1,12 +0,0 @@
-This setup is used for toy_convect and for the XRB stuff. The init
-code takes an input file (one of the _param* files) to determine what
-is going on.
-
--- _params.xrb_mixed.hi_dens.tall.CNO
-
- This is the _params file that is used for the xrb_mixed stuff
-
--- _params.xrb_mixed.hi_dens.tall2.CNO
-
- This version differs from the above one with more buffer beneath
- the convective layer
\ No newline at end of file
diff --git a/Util/initial_models/toy_atm/_params.convective_flame b/Util/initial_models/toy_atm/_params.convective_flame
deleted file mode 100644
index 00f67b8d1..000000000
--- a/Util/initial_models/toy_atm/_params.convective_flame
+++ /dev/null
@@ -1,30 +0,0 @@
-¶ms
-
- model_prefix = "convective_flame_"
-
- nx = 192
-
- dens_base = 1.0
-
- T_star = 0.75
- T_base = 1.0
- T_lo = 1.e-3
-
- H_star = 1.0d0
- delta = 0.04
-
- fuel1_name = "fuel"
- fuel1_frac = 1.0d0
-
- ash1_name = "inert"
- ash1_frac = 1.0d0
-
- xmin = 0.0
- xmax = 7.68
-
- g_const = -4.2e7
-
- low_density_cutoff = 1.d-8
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/_params.convective_flame_tall b/Util/initial_models/toy_atm/_params.convective_flame_tall
deleted file mode 100644
index 1e4033609..000000000
--- a/Util/initial_models/toy_atm/_params.convective_flame_tall
+++ /dev/null
@@ -1,30 +0,0 @@
-¶ms
-
- model_prefix = "convective_flame_"
-
- nx = 192
-
- dens_base = 1.0
-
- T_star = 0.75
- T_base = 1.0
- T_lo = 1.e-2
-
- H_star = 1.25d0
- delta = 0.04
-
- fuel1_name = "fuel"
- fuel1_frac = 1.0d0
-
- ash1_name = "inert"
- ash1_frac = 1.0d0
-
- xmin = 0.0
- xmax = 9.6
-
- g_const = -4.2e7
-
- low_density_cutoff = 1.d-8
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/_params.xrb.flame_wave b/Util/initial_models/toy_atm/_params.xrb.flame_wave
deleted file mode 100644
index 8a467bd35..000000000
--- a/Util/initial_models/toy_atm/_params.xrb.flame_wave
+++ /dev/null
@@ -1,33 +0,0 @@
-¶ms
-
- model_prefix = "flame_wave"
-
- nx = 1536
-
- dens_base = 2e6
-
- T_star = 1.d8
- T_base = 3.81d8
- T_lo = 5.d7
-
- H_star = 1450.d0
- delta = 12.0
-
- fuel1_name = "helium-4"
- fuel1_frac = 1.0d0
-
- ash1_name = "iron-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 61440.0
-
- g_const = -2.0e14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/_params.xrb.flame_wave.2H b/Util/initial_models/toy_atm/_params.xrb.flame_wave.2H
deleted file mode 100644
index db741edc5..000000000
--- a/Util/initial_models/toy_atm/_params.xrb.flame_wave.2H
+++ /dev/null
@@ -1,33 +0,0 @@
-¶ms
-
- model_prefix = "flame_wave"
-
- nx = 2048
-
- dens_base = 2e6
-
- T_star = 1.d8
- T_base = 3.81d8
- T_lo = 5.d7
-
- H_star = 5000.d0
- delta = 12.0
-
- fuel1_name = "helium-4"
- fuel1_frac = 1.0d0
-
- ash1_name = "iron-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 20480.0
-
- g_const = -2.0e14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/_params.xrb.flame_wave.cool b/Util/initial_models/toy_atm/_params.xrb.flame_wave.cool
deleted file mode 100644
index 506775972..000000000
--- a/Util/initial_models/toy_atm/_params.xrb.flame_wave.cool
+++ /dev/null
@@ -1,33 +0,0 @@
-¶ms
-
- model_prefix = "flame_wave"
-
- nx = 1024
-
- dens_base = 2e6
-
- T_star = 5.d7
- T_base = 2.d8
- T_lo = 2.d7
-
- H_star = 5000.d0
- delta = 12.0
-
- fuel1_name = "helium-4"
- fuel1_frac = 1.0d0
-
- ash1_name = "iron-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 20480.0
-
- g_const = -2.0e14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/_params.xrb_mixed.hi_dens.tall.CNO b/Util/initial_models/toy_atm/_params.xrb_mixed.hi_dens.tall.CNO
deleted file mode 100644
index b56de11c5..000000000
--- a/Util/initial_models/toy_atm/_params.xrb_mixed.hi_dens.tall.CNO
+++ /dev/null
@@ -1,51 +0,0 @@
-¶ms
-
- model_prefix = "toy_xrb.hi_dens"
-
- nx = 1536
-
- dens_base = 2e6
-
- T_star = 3.d8
- T_base = 9.5d8
- T_lo = 5.d7
-
- H_star = 1450.d0
- delta = 12.0
-
- fuel1_name = "hydrogen-1"
- fuel1_frac = 0.72d0
-
- fuel2_name = "helium-4"
- fuel2_frac = 0.24d0
-
- fuel3_name = "oxygen-14"
- fuel3_frac = 0.0004
-
- fuel4_name = "oxygen-15"
- fuel4_frac = 0.003
-
- fuel5_name = "magnesium-22"
- fuel5_frac = 0.001
-
- fuel6_name = "sulfur-30"
- fuel6_frac = 0.001
-
- fuel7_name = "nickel-56"
- fuel7_frac = 0.0346
-
- ash1_name = "nickel-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 4608.0
-
- g_const = -2.450d14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/_params.xrb_mixed.hi_dens.tall2.CNO b/Util/initial_models/toy_atm/_params.xrb_mixed.hi_dens.tall2.CNO
deleted file mode 100644
index 3f727211a..000000000
--- a/Util/initial_models/toy_atm/_params.xrb_mixed.hi_dens.tall2.CNO
+++ /dev/null
@@ -1,51 +0,0 @@
-¶ms
-
- model_prefix = "toy_xrb.hi_dens_tall"
-
- nx = 960
-
- dens_base = 2e6
-
- T_star = 3.d8
- T_base = 9.5d8
- T_lo = 5.d7
-
- H_star = 2600.d0
- delta = 12.0
-
- fuel1_name = "hydrogen-1"
- fuel1_frac = 0.72d0
-
- fuel2_name = "helium-4"
- fuel2_frac = 0.24d0
-
- fuel3_name = "oxygen-14"
- fuel3_frac = 0.0004
-
- fuel4_name = "oxygen-15"
- fuel4_frac = 0.003
-
- fuel5_name = "magnesium-22"
- fuel5_frac = 0.001
-
- fuel6_name = "sulfur-30"
- fuel6_frac = 0.001
-
- fuel7_name = "nickel-56"
- fuel7_frac = 0.0346
-
- ash1_name = "nickel-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 5760.0
-
- g_const = -2.450d14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/init_1d_tanh2.f90 b/Util/initial_models/toy_atm/init_1d_tanh2.f90
deleted file mode 100755
index d1d7e915b..000000000
--- a/Util/initial_models/toy_atm/init_1d_tanh2.f90
+++ /dev/null
@@ -1,857 +0,0 @@
-!! Create a 1-d hydrostatic, atmosphere with an isothermal region
-!! (T_star) representing the NS, a hyperbolic tangent rise to a
-!! peak temperature (T_base) representing the base of an accreted
-!! layer, an isoentropic profile down to a lower temperature (T_lo),
-!! and then isothermal. This can serve as an initial model for a
-!! nova or XRB.
-!!
-!! The temperature profile is:
-!!
-!! ^
-!! |
-!! T_base + /\
-!! | / \
-!! | / . \
-!! T_star +-----+ \
-!! | . . \
-!! | \
-!! | . . \
-!! T_lo + +-----------
-!! | . .
-!! +-----+---+---------------> r
-!! | \ /
-!! | delta
-!! |< H_star>|
-!!
-!! We take dens_base, the density at the base of the isentropic layer
-!! as input. The composition is "ash" in the lower isothermal region
-!! and "fuel" in the isentropic and upper isothermal regions. In the
-!! linear transition region, we linearly interpolate the composition.
-!!
-!! The fuel and ash compositions are specified by the fuel?_name,
-!! fuel?_frac and ash?_name, ash?_frac parameters (name of the species
-!! and mass fraction). Where ? = 1,2,3.
-!!
-!! The model is placed into HSE by the following differencing:
-!!
-!! (1/dr) [ _i -
_{i-1} ] = (1/2) [ _i + _{i-1} ] g
-!!
-!! This will be iterated over in tandem with the EOS call,
-!! P(i-1) = P_eos(rho(i-1), T(i-1), X(i-1)
-!!
-
-program init_1d_tanh
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use eos_module, only: eos_input_rt, eos, eos_init
- use eos_type_module, only: eos_t
- !use extern_probin_module, only: use_eos_coulomb
- use network, only : nspec, network_species_index, spec_names, network_init
- use fundamental_constants_module, only: Gconst
-
- implicit none
-
- integer :: i, n
-
- character(len=128) :: params_file
-
- real (kind=dp_t) :: T_base, T_star, T_lo
- real (kind=dp_t) :: dens_base
- real (kind=dp_t) :: H_star, delta
-
- real (kind=dp_t) :: slope_T, slope_xn(nspec)
-
- real (kind=dp_t) :: pres_base, entropy_base
- real (kind=dp_t), DIMENSION(nspec) :: xn_base, xn_star
-
- real (kind=dp_t), allocatable :: xzn_hse(:), xznl_hse(:), xznr_hse(:)
- real (kind=dp_t), allocatable :: model_hse(:,:)
-
- real :: A, B
-
- integer ::nx
-
- integer :: lun1, lun2
-
- ! define convenient indices for the scalars
- integer, parameter :: nvar = 3 + nspec
- integer, parameter :: idens = 1, &
- itemp = 2, &
- ipres = 3, &
- ispec = 4
-
- ! we'll get the composition from the network module
- ! we allow for 3 different species separately in the fuel and ash
- integer :: ifuel1, ifuel2, ifuel3, ifuel4, ifuel5, ifuel6, ifuel7
- integer :: iash1, iash2, iash3, iash4
- character (len=32) :: fuel1_name, fuel2_name, fuel3_name, fuel4_name
- character (len=32) :: fuel5_name, fuel6_name, fuel7_name
- character (len=32) :: ash1_name, ash2_name, ash3_name, ash4_name
- real (kind=dp_t) :: fuel1_frac, fuel2_frac, fuel3_frac, fuel4_frac
- real (kind=dp_t) :: fuel5_frac, fuel6_frac, fuel7_frac
- real (kind=dp_t) :: ash1_frac, ash2_frac, ash3_frac, ash4_frac
- logical :: species_defined
-
- real (kind=dp_t) :: xmin, xmax, dCoord
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone, entropy
- real (kind=dp_t) :: dpd, dpt, dsd, dst
-
- real (kind=dp_t) :: p_want, drho, dtemp, delx
-
- real (kind=dp_t) :: g_zone, g_const, M_enclosed
- logical :: do_invsq_grav
-
- real (kind=dp_t), parameter :: TOL = 1.e-10
-
- integer, parameter :: MAX_ITER = 250
-
- integer :: iter
-
- logical :: converged_hse, fluff
-
- real (kind=dp_t), dimension(nspec) :: xn
-
- real (kind=dp_t) :: low_density_cutoff, smallx
-
- integer :: index_base
-
- logical :: isentropic
-
- character (len=256) :: outfile, outfile2
- character (len=8) :: num
- character (len=32) :: deltastr, dxstr
- character (len=32) :: num_to_unitstring
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- character (len=128) :: model_prefix
-
- integer :: narg
-
- logical :: index_base_from_temp
-
- type (eos_t) :: eos_state
-
- namelist /params/ nx, dens_base, T_star, T_base, T_lo, H_star, delta, &
- fuel1_name, fuel2_name, fuel3_name, fuel4_name, &
- fuel5_name, fuel6_name, fuel7_name, &
- ash1_name, ash2_name, ash3_name, ash4_name, &
- fuel1_frac, fuel2_frac, fuel3_frac, fuel4_frac, &
- fuel5_frac, fuel6_frac, fuel7_frac, &
- ash1_frac, ash2_frac, ash3_frac, ash4_frac, &
- xmin, xmax, g_const, do_invsq_grav, M_enclosed, &
- low_density_cutoff, model_prefix, index_base_from_temp
-
- ! determine if we specified a runtime parameters file or use the default
- narg = command_argument_count()
-
- if (narg == 0) then
- params_file = "_params"
- else
- call get_command_argument(1, value = params_file)
- endif
-
-
-
-
- ! define defaults for the parameters for this model
- nx = 640
-
- dens_base = 2.d6
-
- T_star = 1.d8
- T_base = 5.d8
- T_lo = 5.e7
-
- H_star = 500.d0
- delta = 25.d0
-
- fuel1_name = "helium-4"
- fuel2_name = ""
- fuel3_name = ""
- fuel4_name = ""
- fuel5_name = ""
- fuel6_name = ""
- fuel7_name = ""
-
- ash1_name = "iron-56"
- ash2_name = ""
- ash3_name = ""
- ash4_name = ""
-
- fuel1_frac = ONE
- fuel2_frac = ZERO
- fuel3_frac = ZERO
- fuel4_frac = ZERO
- fuel5_frac = ZERO
- fuel6_frac = ZERO
- fuel7_frac = ZERO
-
- ash1_frac = ONE
- ash2_frac = ZERO
- ash3_frac = ZERO
- ash4_frac = ZERO
-
- xmin = 0.0_dp_t
- xmax = 2.e3_dp_t
-
- model_prefix = "model"
-
- index_base_from_temp = .false.
-
- ! if do_invsq_grav = .false. we will use g_const for the
- ! gravitational acceleration. Otherwise, we will compute gravity
- ! from M_enclosed and the distance from the origin
- M_enclosed = 2.d33
- g_const = -2.450d14
- do_invsq_grav = .false.
-
- low_density_cutoff = 1.d-4
-
- smallx = 1.d-10
-
-
- ! this comes in via extern_probin_module -- override the default
- ! here if we want
- !use_eos_coulomb = .true.
-
-
- ! initialize the EOS and network
- call eos_init()
- call network_init()
-
- ! check the namelist for any changed parameters
- open(unit=11, file=params_file, status="old", action="read")
- read(unit=11, nml=params)
- close(unit=11)
-
-
- ! get the species indices
- species_defined = .true.
- ifuel1 = network_species_index(trim(fuel1_name))
- if (ifuel1 < 0) species_defined = .false.
-
- if (fuel2_name /= "") then
- ifuel2 = network_species_index(trim(fuel2_name))
- if (ifuel2 < 0) species_defined = .false.
- endif
-
- if (fuel3_name /= "") then
- ifuel3 = network_species_index(trim(fuel3_name))
- if (ifuel3 < 0) species_defined = .false.
- endif
-
- if (fuel4_name /= "") then
- ifuel4 = network_species_index(trim(fuel4_name))
- if (ifuel4 < 0) species_defined = .false.
- endif
-
- if (fuel5_name /= "") then
- ifuel5 = network_species_index(trim(fuel5_name))
- if (ifuel5 < 0) species_defined = .false.
- endif
-
- if (fuel6_name /= "") then
- ifuel6 = network_species_index(trim(fuel6_name))
- if (ifuel6 < 0) species_defined = .false.
- endif
-
- if (fuel7_name /= "") then
- ifuel7 = network_species_index(trim(fuel7_name))
- if (ifuel7 < 0) species_defined = .false.
- endif
-
-
- iash1 = network_species_index(trim(ash1_name))
- if (iash1 < 0) species_defined = .false.
-
- if (ash2_name /= "") then
- iash2 = network_species_index(trim(ash2_name))
- if (iash2 < 0) species_defined = .false.
- endif
-
- if (ash3_name /= "") then
- iash3 = network_species_index(trim(ash3_name))
- if (iash3 < 0) species_defined = .false.
- endif
-
- if (ash4_name /= "") then
- iash4 = network_species_index(trim(ash4_name))
- if (iash4 < 0) species_defined = .false.
- endif
-
- if (.not. species_defined) then
- print *, ifuel1, ifuel2, ifuel3, ifuel4, ifuel5, ifuel6, ifuel7
- print *, iash1, iash2, iash3, iash4
- call bl_error("ERROR: species not defined")
- endif
-
-
-
- ! set the composition of the underlying star
- xn_star(:) = smallx
- xn_star(iash1) = ash1_frac
- if (ash2_name /= "") xn_star(iash2) = ash2_frac
- if (ash3_name /= "") xn_star(iash3) = ash3_frac
- if (ash4_name /= "") xn_star(iash4) = ash4_frac
-
- ! and the composition of the accreted layer
- xn_base(:) = smallx
- xn_base(ifuel1) = fuel1_frac
- if (fuel2_name /= "") xn_base(ifuel2) = fuel2_frac
- if (fuel3_name /= "") xn_base(ifuel3) = fuel3_frac
- if (fuel4_name /= "") xn_base(ifuel4) = fuel4_frac
- if (fuel5_name /= "") xn_base(ifuel5) = fuel5_frac
- if (fuel6_name /= "") xn_base(ifuel6) = fuel6_frac
- if (fuel7_name /= "") xn_base(ifuel7) = fuel7_frac
-
- ! check if they sum to 1
- if (abs(sum(xn_star) - ONE) > nspec*smallx) then
- call bl_error("ERROR: ash mass fractions don't sum to 1")
- endif
-
- if (abs(sum(xn_base) - ONE) > nspec*smallx) then
- call bl_error("ERROR: fuel mass fractions don't sum to 1")
- endif
-
-
-
-!-----------------------------------------------------------------------------
-! Create a 1-d uniform grid that is identical to the mesh that we are
-! mapping onto, and then we want to force it into HSE on that mesh.
-!-----------------------------------------------------------------------------
-
- ! allocate storage
- allocate(xzn_hse(nx))
- allocate(xznl_hse(nx))
- allocate(xznr_hse(nx))
- allocate(model_hse(nx,nvar))
-
-
- ! compute the coordinates of the new gridded function
- dCoord = (xmax - xmin) / dble(nx)
-
- do i = 1, nx
- xznl_hse(i) = xmin + (dble(i) - ONE)*dCoord
- xzn_hse(i) = xmin + (dble(i) - HALF)*dCoord
- xznr_hse(i) = xmin + (dble(i))*dCoord
- enddo
-
-
- ! find the index of the base height
- index_base = -1
- do i = 1, nx
- if (xzn_hse(i) >= xmin + H_star + delta) then
- index_base = i+1
- exit
- endif
- enddo
-
- if (index_base == -1) then
- print *, 'ERROR: base_height not found on grid'
- call bl_error('ERROR: invalid base_height')
- endif
-
-
-!-----------------------------------------------------------------------------
-! put the model onto our new uniform grid
-!-----------------------------------------------------------------------------
-
- fluff = .false.
-
- ! determine the conditions at the base
- eos_state%T = T_base
- eos_state%rho = dens_base
- eos_state%xn(:) = xn_base(:)
-
- call eos(eos_input_rt, eos_state)
-
- ! store the conditions at the base -- we'll use the entropy later
- ! to constrain the isentropic layer
- pres_base = eos_state%p
- entropy_base = eos_state%s
-
- print *, 'entropy_base = ', entropy_base
- print *, 'pres_base = ', pres_base
-
- ! set an initial temperature profile and composition
- do i = 1, nx
-
- !hyperbolic tangent transition:
- model_hse(i,ispec:ispec-1+nspec) = xn_star(1:nspec) + &
- HALF*(xn_base(1:nspec) - xn_star(1:nspec))* &
- (ONE + tanh((xzn_hse(i) - (xmin + H_star - delta) + delta)/delta))
-
- model_hse(i,itemp) = T_star + HALF*(T_base - T_star)* &
- (ONE + tanh((xzn_hse(i) - (xmin + H_star - delta) + delta)/delta))
-
-
- ! the density and pressure will be determined via HSE,
- ! for now, set them to the base conditions
- model_hse(i,idens) = dens_base
- model_hse(i,ipres) = pres_base
-
- enddo
-
-
- if (index_base_from_temp) then
- ! find the index of the base height -- look at the temperature for this
- index_base = -1
- do i = 1, nx
- !if (xzn_hse(i) >= xmin + H_star + delta) then
- if (model_hse(i,itemp) > 0.9995*T_base) then
- index_base = i+1
- exit
- endif
- enddo
-
- if (index_base == -1) then
- print *, 'ERROR: base_height not found on grid'
- call bl_error('ERROR: invalid base_height')
- endif
- endif
-
- print *, 'index_base = ', index_base
-
- ! make the base thermodynamics consistent for this base point -- that is
- ! what we will integrate from!
- eos_state%rho = model_hse(index_base,idens)
- eos_state%T = model_hse(index_base,itemp)
- eos_state%xn(:) = model_hse(index_base,ispec:ispec-1+nspec)
-
- call eos(eos_input_rt, eos_state)
-
- model_hse(index_base,ipres) = eos_state%p
-
-
-!-----------------------------------------------------------------------------
-! HSE + entropy solve
-!-----------------------------------------------------------------------------
-
-! the HSE state will be done putting creating an isentropic state until
-! the temperature goes below T_lo -- then we will do isothermal.
-! also, once the density goes below low_density_cutoff, we stop HSE
-
- isentropic = .true.
-
- !---------------------------------------------------------------------------
- ! integrate up
- !---------------------------------------------------------------------------
- do i = index_base+1, nx
-
- delx = xzn_hse(i) - xzn_hse(i-1)
-
- ! compute the gravitation acceleration at the lower edge
- if (do_invsq_grav) then
- g_zone = -Gconst*M_enclosed/xznl_hse(i)**2
- else
- g_zone = g_const
- endif
-
- ! we've already set initial guesses for density, temperature, and
- ! composition
- dens_zone = model_hse(i,idens)
- temp_zone = model_hse(i,itemp)
- xn(:) = model_hse(i,ispec:nvar)
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- if (.not. fluff) then
-
- do iter = 1, MAX_ITER
-
- if (isentropic) then
-
- ! get the pressure we want from the HSE equation, just the
- ! zone below the current. Note, we are using an average of
- ! the density of the two zones as an approximation of the
- ! interface value -- this means that we need to iterate for
- ! find the density and pressure that are consistent
-
- ! furthermore, we need to get the entropy that we need,
- ! which will come from adjusting the temperature in
- ! addition to the density.
-
- ! HSE differencing
- p_want = model_hse(i-1,ipres) + &
- delx*0.5*(dens_zone + model_hse(i-1,idens))*g_zone
-
-
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_base - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
-
- ! now we know the pressure and the entropy that we want, so we
- ! need to find the temperature and density through a two
- ! dimensional root find
-
- ! (t, rho) -> (p, s)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = entropy_base - entropy
-
- dtemp = ((dsd/(dpd-0.5*delx*g_zone))*A - B)/ &
- (dsd*dpt/(dpd -0.5*delx*g_zone) - dst)
-
- drho = (A - dpt*dtemp)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
- temp_zone = max(0.9_dp_t*temp_zone, &
- min(temp_zone + dtemp, 1.1_dp_t*temp_zone))
-
-
- ! check if the density falls below our minimum cut-off --
- ! if so, floor it
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = T_lo
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- ! if (A < TOL .and. B < ETOL) then
- if (abs(drho) < TOL*dens_zone .and. &
- abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- else
-
- ! do isothermal
- p_want = model_hse(i-1,ipres) + &
- delx*0.5*(dens_zone + model_hse(i-1,idens))*g_zone
-
- temp_zone = T_lo
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- if (dens_zone < low_density_cutoff) then
-
- dens_zone = low_density_cutoff
- temp_zone = T_lo
- converged_hse = .TRUE.
- fluff = .TRUE.
- exit
-
- endif
-
- endif
-
- if (temp_zone < T_lo) then
- temp_zone = T_lo
- isentropic = .false.
- endif
-
- enddo
-
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate up'
- print *, dens_zone, temp_zone
- print *, p_want, entropy_base, entropy
- print *, drho, dtemp
- call bl_error('Error: HSE non-convergence')
-
- endif
-
- else
- dens_zone = low_density_cutoff
- temp_zone = T_lo
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! update the thermodynamics in this zone
- model_hse(i,idens) = dens_zone
- model_hse(i,itemp) = temp_zone
- model_hse(i,ipres) = pres_zone
-
-
- ! to make this process converge faster, set the density in the
- ! next zone to the density in this zone
- ! model_hse(i+1,idens) = dens_zone
-
- enddo
-
-
- !---------------------------------------------------------------------------
- ! integrate down -- using the temperature profile defined above
- !---------------------------------------------------------------------------
- do i = index_base-1, 1, -1
-
- delx = xzn_hse(i+1) - xzn_hse(i)
-
- ! compute the gravitation acceleration at the upper edge
- if (do_invsq_grav) then
- g_zone = -Gconst*M_enclosed/xznr_hse(i)**2
- else
- g_zone = g_const
- endif
-
- ! we already set the temperature and composition profiles
- temp_zone = model_hse(i,itemp)
- xn(:) = model_hse(i,ispec:nvar)
-
- ! use our previous initial guess for density
- dens_zone = model_hse(i+1,idens)
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
- do iter = 1, MAX_ITER
-
- ! get the pressure we want from the HSE equation, just the
- ! zone below the current. Note, we are using an average of
- ! the density of the two zones as an approximation of the
- ! interface value -- this means that we need to iterate for
- ! find the density and pressure that are consistent
-
- ! HSE differencing
- p_want = model_hse(i+1,ipres) - &
- delx*0.5*(dens_zone + model_hse(i+1,idens))*g_zone
-
-
- ! we will take the temperature already defined in model_hse
- ! so we only need to zero:
- ! A = p_want - p(rho)
-
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- A = p_want - pres_zone
-
- drho = A/(dpd + 0.5*delx*g_zone)
-
- dens_zone = max(0.9_dp_t*dens_zone, &
- min(dens_zone + drho, 1.1_dp_t*dens_zone))
-
-
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- exit
- endif
-
- enddo
-
- if (.NOT. converged_hse) then
-
- print *, 'Error zone', i, ' did not converge in init_1d'
- print *, 'integrate down'
- print *, dens_zone, temp_zone
- print *, p_want
- print *, drho
- call bl_error('Error: HSE non-convergence')
-
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- ! (t, rho) -> (p)
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- eos_state%xn(:) = xn(:)
-
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! update the thermodynamics in this zone
- model_hse(i,idens) = dens_zone
- model_hse(i,itemp) = temp_zone
- model_hse(i,ipres) = pres_zone
-
- enddo
-
- write(num,'(i8)') nx
-
- deltastr = num_to_unitstring(delta)
- dxstr = num_to_unitstring(dCoord)
-
- outfile = trim(model_prefix) // ".hse." // "tanh.delta_" // trim(adjustl(deltastr)) // ".dx_" // trim(adjustl(dxstr))
- outfile2 = trim(outfile) // ".extras"
-
- open (newunit=lun1, file=outfile, status="unknown")
- open (newunit=lun2, file=outfile2, status="unknown")
-
- write (lun1,1001) "# npts = ", nx
- write (lun1,1001) "# num of variables = ", nvar
- write (lun1,1002) "# density"
- write (lun1,1002) "# temperature"
- write (lun1,1002) "# pressure"
-
- do n = 1, nspec
- write (lun1, 1003) "# ", spec_names(n)
- enddo
-
-1000 format (1x, 100(g26.16, 1x))
-1001 format (a, i5)
-1002 format (a)
-1003 format (a,a)
-
- do i = 1, nx
-
- write (lun1,1000) xzn_hse(i), model_hse(i,idens), model_hse(i,itemp), model_hse(i,ipres), &
- (model_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
- ! some metadata
- write (lun1, 1002) "# generated by toy_atm"
- write (lun1, 1003) "# inputs file", params_file
-
-
- write (lun2,1001), "# npts = ", nx
- write (lun2,1001), "# num of variables = ", 2
- write (lun2,1002), "# entropy"
- write (lun2,1002), "# c_s"
-
- ! test: bulk EOS call -- Maestro will do this once we are mapped, so make
- ! sure that we are in HSE with updated thermodynamics
- do i = 1, nx
- eos_state%rho = model_hse(i,idens)
- eos_state%T = model_hse(i,itemp)
- eos_state%xn(:) = model_hse(i,ispec:ispec-1+nspec)
-
- call eos(eos_input_rt, eos_state)
-
- model_hse(i,ipres) = eos_state%p
-
- write (lun2,1000), xzn_hse(i), eos_state%s, eos_state%cs
- enddo
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
-
- ! compute the gravitation acceleration at the lower edge
- if (do_invsq_grav) then
- g_zone = -Gconst*M_enclosed/xznl_hse(i)**2
- else
- g_zone = g_const
- endif
-
- dpdr = (model_hse(i,ipres) - model_hse(i-1,ipres))/delx
- rhog = HALF*(model_hse(i,idens) + model_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_hse(i+1,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
-
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
- close (unit=lun1)
- close (unit=lun2)
-
-end program init_1d_tanh
-
-
-function num_to_unitstring(value)
-
- use bl_types
- implicit none
-
- real (kind=dp_t) :: value
- character (len=32) :: num_to_unitstring
- character (len=16) :: temp
-
- if (value > 1.d5) then
-
- ! work in km
- write(temp,'(f6.3)') value/1.d5
- num_to_unitstring = trim(temp) // "km"
- else
-
- ! work in cm
- if (value > 1.d3) then
- write(temp,'(f8.3)') value
- num_to_unitstring = trim(temp) // "cm"
-
- else
- write(temp,'(f6.3)') value
- num_to_unitstring = trim(temp) // "cm"
- endif
-
- endif
-
- return
-end function num_to_unitstring
diff --git a/Util/initial_models/toy_atm/old_inputs/_params.xrb b/Util/initial_models/toy_atm/old_inputs/_params.xrb
deleted file mode 100644
index 3c41a6638..000000000
--- a/Util/initial_models/toy_atm/old_inputs/_params.xrb
+++ /dev/null
@@ -1,29 +0,0 @@
-¶ms
-
- model_prefix = "toy_xrb"
-
- nx = 1280
-
- dens_base = 2.d6
-
- T_star = 1.d8
- T_base = 5.d8
- T_lo = 5.d7
-
- H_star = 500.d0
- delta = 25.d0
-
- fuel1_name = "helium-4"
- ash1_name = "iron-56"
-
- fuel1_frac = 1.0d0
- ash1_frac = 1.0d0
-
- xmin = 0.0
- xmax = 2.d3
-
- g_const = -2.450d14
-
- low_density_cutoff = 1.d-4
-
-/
diff --git a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hi_dens.tall.approx8 b/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hi_dens.tall.approx8
deleted file mode 100644
index 57d4af1ad..000000000
--- a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hi_dens.tall.approx8
+++ /dev/null
@@ -1,51 +0,0 @@
-¶ms
-
- model_prefix = "toy_xrb.hi_dens"
-
- nx = 768
-
- dens_base = 2e6
-
- T_star = 3.d8
- T_base = 9.5d8
- T_lo = 5.d7
-
- H_star = 1450.d0
- delta = 12.0
-
- fuel1_name = "hydrogen-1"
- fuel1_frac = 0.72d0
-
- fuel2_name = "helium-4"
- fuel2_frac = 0.24d0
-
- fuel3_name = "nitrogen-14"
- fuel3_frac = 0.0004
-
- fuel4_name = "oxygen-16"
- fuel4_frac = 0.003
-
- fuel5_name = "neon-20"
- fuel5_frac = 0.001
-
- fuel6_name = "magnesium-24"
- fuel6_frac = 0.001
-
- fuel7_name = "nickel-56"
- fuel7_frac = 0.0346
-
- ash1_name = "nickel-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 4608.0
-
- g_const = -2.450d14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hot.tall.CNO b/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hot.tall.CNO
deleted file mode 100644
index 115d2cb53..000000000
--- a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hot.tall.CNO
+++ /dev/null
@@ -1,51 +0,0 @@
-¶ms
-
- model_prefix = "toy_xrb.hot"
-
- nx = 1536
-
- dens_base = 6.3e5
-
- T_star = 3.d8
- T_base = 8.8d8
- T_lo = 5.d7
-
- H_star = 1600.d0
- delta = 12.0
-
- fuel1_name = "hydrogen-1"
- fuel1_frac = 0.72d0
-
- fuel2_name = "helium-4"
- fuel2_frac = 0.24d0
-
- fuel3_name = "oxygen-14"
- fuel3_frac = 0.0004
-
- fuel4_name = "oxygen-15"
- fuel4_frac = 0.003
-
- fuel5_name = "magnesium-22"
- fuel5_frac = 0.001
-
- fuel6_name = "sulfur-30"
- fuel6_frac = 0.001
-
- fuel7_name = "nickel-56"
- fuel7_frac = 0.0346
-
- ash1_name = "nickel-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 4608.0
-
- g_const = -2.450d14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hot2.tall.CNO b/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hot2.tall.CNO
deleted file mode 100644
index 154de05d6..000000000
--- a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.hot2.tall.CNO
+++ /dev/null
@@ -1,51 +0,0 @@
-¶ms
-
- model_prefix = "toy_xrb.hot2"
-
- nx = 512
-
- dens_base = 5.93e5
-
- T_star = 3.d8
- T_base = 9.5d8
- T_lo = 5.d7
-
- H_star = 950.d0
- delta = 12.0
-
- fuel1_name = "hydrogen-1"
- fuel1_frac = 0.72d0
-
- fuel2_name = "helium-4"
- fuel2_frac = 0.24d0
-
- fuel3_name = "oxygen-14"
- fuel3_frac = 0.0004
-
- fuel4_name = "oxygen-15"
- fuel4_frac = 0.003
-
- fuel5_name = "magnesium-22"
- fuel5_frac = 0.001
-
- fuel6_name = "sulfur-30"
- fuel6_frac = 0.001
-
- fuel7_name = "nickel-56"
- fuel7_frac = 0.0346
-
- ash1_name = "nickel-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 3072.0
-
- g_const = -2.450d14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.tall.CNO b/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.tall.CNO
deleted file mode 100644
index 945a983a8..000000000
--- a/Util/initial_models/toy_atm/old_inputs/_params.xrb_mixed.tall.CNO
+++ /dev/null
@@ -1,51 +0,0 @@
-¶ms
-
- model_prefix = "toy_xrb"
-
- nx = 1024
-
- dens_base = 7.e5
-
- T_star = 3.d8
- T_base = 7.5d8
- T_lo = 5.d7
-
- H_star = 950.d0
- delta = 12.0
-
- fuel1_name = "hydrogen-1"
- fuel1_frac = 0.72d0
-
- fuel2_name = "helium-4"
- fuel2_frac = 0.24d0
-
- fuel3_name = "oxygen-14"
- fuel3_frac = 0.0004
-
- fuel4_name = "oxygen-15"
- fuel4_frac = 0.003
-
- fuel5_name = "magnesium-22"
- fuel5_frac = 0.001
-
- fuel6_name = "sulfur-30"
- fuel6_frac = 0.001
-
- fuel7_name = "nickel-56"
- fuel7_frac = 0.0346
-
- ash1_name = "nickel-56"
- ash1_frac = 1.0d0
-
-
-
-
- xmin = 0.0
- xmax = 3072.0
-
- g_const = -2.450d14
-
- low_density_cutoff = 1.d-4
-
- index_base_from_temp = T
-/
diff --git a/Util/initial_models/urca/spherical/GInitModels.mak b/Util/initial_models/urca/spherical/GInitModels.mak
deleted file mode 100644
index 7b3efdb60..000000000
--- a/Util/initial_models/urca/spherical/GInitModels.mak
+++ /dev/null
@@ -1,213 +0,0 @@
-# A set of useful macros for putting together one of the initial model
-# generator routines
-
-# include the main Makefile stuff
-include $(AMREX_HOME)/Tools/F_mk/GMakedefs.mak
-
-# default target (make just takes the one that appears first)
-ALL: init_1d.$(suf).exe
-
-
-#-----------------------------------------------------------------------------
-# core AMReX directories
-AMREX_CORE := Src/F_BaseLib
-
-
-#-----------------------------------------------------------------------------
-# default to $(MICROPHYSICS_HOME) for the EOS unless we are gamma_law_general
-ifeq ($(EOS_DIR), gamma_law_general)
- EOS_TOP_DIR := $(MAESTRO_HOME)/Microphysics/EOS
-else
- EOS_TOP_DIR := $(MICROPHYSICS_HOME)/EOS
-endif
-
-# we need all the thermodynamics
-FPP_DEFINES += -DEXTRA_THERMO
-
-ifeq ($(EOS_DIR), helmeos)
- EOS_DIR := helmholtz
- $(info EOS_DIR = helmeos is deprecated. Please use helmholtz instead)
-endif
-
-# the helmeholtz eos has an include file -- also add a target to link
-# the table into the problem directory.
-ifeq ($(findstring helmholtz, $(EOS_DIR)), helmholtz)
- EOS_PATH := $(EOS_TOP_DIR)/helmholtz
- ALL: table
-endif
-
-table:
- @if [ ! -f helm_table.dat ]; then echo ${bold}Linking helm_table.dat${normal}; ln -s $(EOS_PATH)/helm_table.dat .; fi
-
-# For the URCA network in Microphysics, link the rate tables
-ifeq ($(findstring URCA-simple, $(NETWORK_DIR)), URCA-simple)
- ALL: urcatables
-endif
-
-
-urcatables:
- @if [ ! -f 23Ne-23Na_betadecay.dat ]; then echo ${bold}Linking 23Ne-23Na_betadecay.dat${normal}; ln -s $(NETWORK_TOP_DIR)/$(NETWORK_DIR)/23Ne-23Na_betadecay.dat .; fi
- @if [ ! -f 23Na-23Ne_electroncapture.dat ]; then echo ${bold}Linking 23Na-23Ne_electroncapture.dat${normal}; ln -s $(NETWORK_TOP_DIR)/$(NETWORK_DIR)/23Na-23Ne_electroncapture.dat .; fi
-
-
-# All networks except general_null should pull in the Microphysics repository.
-ifneq ($(findstring general_null, $(NETWORK_DIR)), general_null)
- NETWORK_TOP_DIR := $(MICROPHYSICS_HOME)/networks
- include $(NETWORK_TOP_DIR)/GNetwork.mak
-else
- NETWORK_TOP_DIR := $(MAESTRO_TOP_DIR)/Microphysics/networks
- MICROPHYS_CORE += $(NETWORK_TOP_DIR) $(NETWORK_TOP_DIR)/$(NETWORK_DIR)
-endif
-
-ifdef SYSTEM_BLAS
- libraries += $(BLAS_LIBRARY)
-endif
-
-# are we using the stellar conductivity?
-ifeq ($(findstring stellar, $(CONDUCTIVITY_DIR)), stellar)
- CONDUCTIVITY_TOP_DIR := $(MICROPHYSICS_HOME)/conductivity
-endif
-
-ifndef CONDUCTIVITY_TOP_DIR
- CONDUCTIVITY_TOP_DIR := $(MAESTRO_TOP_DIR)/Microphysics/conductivity
-endif
-
-
-
-# add in the network, EOS, and conductivity
-MICROPHYS_CORE += $(MAESTRO_TOP_DIR)/Microphysics/EOS \
- $(MAESTRO_TOP_DIR)/Microphysics/networks \
- $(EOS_TOP_DIR) \
- $(EOS_TOP_DIR)/$(EOS_DIR) \
- $(MAESTRO_TOP_DIR)/Microphysics/conductivity \
- $(CONDUCTIVITY_TOP_DIR)/$(CONDUCTIVITY_DIR)
-
-# get any additional network dependencies
-include $(NETWORK_TOP_DIR)/$(strip $(NETWORK_DIR))/NETWORK_REQUIRES
-
-
-
-#-----------------------------------------------------------------------------
-# extra directory
-ifndef EXTRA_TOP_DIR
- EXTRA_TOP_DIR := $(MAESTRO_TOP_DIR)/
-endif
-
-EXTRAS := $(addprefix $(EXTRA_TOP_DIR)/, $(EXTRA_DIR))
-
-ifndef EXTRA_TOP_DIR2
- EXTRA_TOP_DIR2 := $(MAESTRO_TOP_DIR)/
-endif
-
-EXTRAS += $(addprefix $(EXTRA_TOP_DIR2)/, $(EXTRA_DIR2))
-
-ifdef NEED_VODE
- Fmdirs += Util/VODE Util/LINPACK Util/BLAS
-endif
-
-ifdef NEED_BLAS
- Fmdirs += Util/BLAS
-endif
-
-ifdef NEED_LINPACK
- UTIL_CORE += Util/LINPACK
-endif
-
-ifdef NEED_VBDF
- UTIL_CORE += Util/VBDF
-endif
-
-Fmdirs += Util/model_parser Util/simple_log
-
-
-# explicitly add in any source defined in the build directory
-f90sources += $(MODEL_SOURCES)
-
-
-#-----------------------------------------------------------------------------
-# core AMReX directories
-Fmpack := $(foreach dir, $(AMREX_CORE), $(AMREX_HOME)/$(dir)/GPackage.mak)
-Fmlocs := $(foreach dir, $(AMREX_CORE), $(AMREX_HOME)/$(dir))
-Fmincs :=
-
-# auxillary directories
-Fmpack += $(foreach dir, $(Fmdirs), $(MAESTRO_TOP_DIR)/$(dir)/GPackage.mak)
-Fmpack += $(foreach dir, $(MICROPHYS_CORE), $(dir)/GPackage.mak)
-
-Fmlocs += $(foreach dir, $(Fmdirs), $(MAESTRO_TOP_DIR)/$(dir))
-Fmlocs += $(foreach dir, $(MICROPHYS_CORE), $(dir))
-
-Fmincs += $(foreach dir, $(Fmincludes), $(MAESTRO_TOP_DIR)/$(dir))
-
-# Extras
-Fmpack += $(foreach dir, $(EXTRAS), $(dir)/GPackage.mak)
-Fmlocs += $(foreach dir, $(EXTRAS), $(dir))
-
-# include the necessary GPackage.mak files that define this setup
-include $(Fmpack)
-
-
-
-# we need a probin.f90, since the various microphysics routines can
-# have runtime parameters
-f90sources += probin.f90
-
-PROBIN_TEMPLATE := $(MAESTRO_TOP_DIR)/Util/parameters/dummy.probin.template
-PROBIN_PARAMETER_DIRS = $(MAESTRO_TOP_DIR)/Util/initial_models/
-EXTERN_PARAMETER_DIRS += $(MICROPHYS_CORE) $(NETWORK_TOP_DIR)
-
-
-PROBIN_PARAMETERS := $(shell $(AMREX_HOME)/Tools/F_scripts/findparams.py $(PROBIN_PARAMETER_DIRS))
-EXTERN_PARAMETERS := $(shell $(AMREX_HOME)/Tools/F_scripts/findparams.py $(EXTERN_PARAMETER_DIRS))
-
-probin.f90: $(PROBIN_PARAMETERS) $(EXTERN_PARAMETERS) $(PROBIN_TEMPLATE)
- @echo " "
- @echo "${bold}WRITING probin.f90${normal}"
- $(AMREX_HOME)/Tools/F_scripts/write_probin.py \
- -t $(PROBIN_TEMPLATE) -o probin.f90 -n probin \
- --pa "$(PROBIN_PARAMETERS)" --pb "$(EXTERN_PARAMETERS)"
- @echo " "
-
-
-
-
-
-# vpath defines the directories to search for the source files
-
-# VPATH_LOCATIONS to first search in the problem directory
-# Note: GMakerules.mak will include '.' at the start of the
-VPATH_LOCATIONS += $(Fmlocs)
-
-
-# we need the MAESTRO constants
-f90sources += constants_cgs.f90
-VPATH_LOCATIONS += $(MAESTRO_TOP_DIR)/Source
-
-
-# list of directories to put in the Fortran include path
-FINCLUDE_LOCATIONS += $(Fmincs)
-
-
-init_1d.$(suf).exe: $(objects)
- $(LINK.f90) -o init_1d.$(suf).exe $(objects) $(libraries)
- @echo SUCCESS
-
-
-# include the fParallel Makefile rules
-include $(AMREX_HOME)/Tools/F_mk/GMakerules.mak
-
-
-#-----------------------------------------------------------------------------
-# for debugging. To see the value of a Makefile variable,
-# e.g. Fmlocs, simply do "make print-Fmlocs". This will
-# print out the value.
-print-%: ; @echo $* is $($*)
-
-
-#-----------------------------------------------------------------------------
-# cleaning. Add more actions to 'clean' and 'realclean' to remove
-# probin.f90 and build_info.f90 -- this is where the '::' in make comes
-# in handy
-clean::
- $(RM) probin.f90
- $(RM) build_info.f90
diff --git a/Util/initial_models/urca/spherical/GNUmakefile b/Util/initial_models/urca/spherical/GNUmakefile
deleted file mode 100644
index 740bbbc69..000000000
--- a/Util/initial_models/urca/spherical/GNUmakefile
+++ /dev/null
@@ -1,25 +0,0 @@
-NDEBUG :=
-MPI :=
-OMP :=
-
-COMP := gfortran
-
-MKVERBOSE := t
-
-SDC :=
-
-# location of top-level MAESTRO directory
-MAESTRO_TOP_DIR = ../../../..
-
-# EOS and network
-EOS_TOP_DIR := $(MICROPHYSICS_HOME)/EOS
-EOS_DIR := helmholtz
-CONDUCTIVITY_DIR := stellar
-NETWORK_TOP_DIR := $(MICROPHYSICS_HOME)/networks
-NETWORK_DIR := ignition_reaclib/URCA-simple
-
-# the local sources needed to build the initial model generator
-MODEL_SOURCES := init_1d.f90
-MODEL_SOURCES += urca_composition.f90
-
-include GInitModels.mak
diff --git a/Util/initial_models/urca/spherical/init_1d.f90 b/Util/initial_models/urca/spherical/init_1d.f90
deleted file mode 100644
index c6df519f1..000000000
--- a/Util/initial_models/urca/spherical/init_1d.f90
+++ /dev/null
@@ -1,635 +0,0 @@
-!! generate an initial model for spherical geometry with a
-!! uniform composition. Here we take a base density and temperature
-!! and use HSE and constant entropy to generate the model.
-
-program init_1d
-
- use bl_types
- use bl_constants_module
- use bl_error_module
- use eos_module, only: eos, eos_input_rt, eos_init
- use eos_type_module, only: eos_t
- use extern_probin_module, only: use_eos_coulomb
- use network
- use actual_burner_module, only: actual_burner_init
- use fundamental_constants_module, only: Gconst
- use urca_composition_module
-
- implicit none
-
- integer :: i, j, n
-
- integer :: nx
-
- real (kind=dp_t) :: temp_base, dens_base
-
- real (kind=dp_t), allocatable :: xzn_hse(:), xznl(:), xznr(:)
- real (kind=dp_t), allocatable :: model_hse(:,:), M_enclosed(:)
-
- ! define convenient indices for the scalars
- integer, parameter :: nvar = 3 + nspec
- integer, parameter :: idens = 1, &
- itemp = 2, &
- ipres = 3, &
- ispec = 4
-
- real (kind=dp_t), parameter :: M_sun = 1.9891e33
-
- ! we'll get the composition indices from the network module
- integer, save :: ihe4, ic12, io16, ine20, ine23, ina23, img23
-
- integer :: narg
- character(len=128) :: params_file
-
- real (kind=dp_t), save :: xmin, xmax, dCoord
-
- real (kind=dp_t) :: dens_zone, temp_zone, pres_zone
- real (kind=dp_t) :: dpd, dpt, dsd, dst
-
- real (kind=dp_t) :: p_want, drho, dtemp, delx
- real (kind=dp_t), allocatable :: entropy_store(:), entropy_want(:)
-
- real (kind=dp_t) :: g_zone, try_tol
-
- real (kind=dp_t) :: TOL = 1.e-11
-
- integer :: MAX_ITER = 1000000
- integer :: MAX_RETRY = 50
-
- integer :: iter, iretry
-
- logical :: converged_hse, fluff
-
- real (kind=dp_t), save :: low_density_cutoff, smallx, dens_conv_zone, M_conv_zone
-
- logical :: test_hse_convergence = .true.
-
- real (kind=dp_t), save :: temp_before_fluff, temp_fluff
-
- character (len=128) :: fluff_type = "continuous"
-
- logical :: isentropic
-
- character (len=256) :: outfile, prefix
- character (len=8) num
-
- real (kind=dp_t) :: max_hse_error, dpdr, rhog
-
- real (kind=dp_t) :: dtol_fac = 0.000001_dp_t
-
- integer :: i_conv, i_fluff
-
- type (eos_t) :: eos_state
-
- namelist /params/ nx, dens_base, temp_base, &
- low_density_cutoff, dens_conv_zone, M_conv_zone, temp_fluff, &
- test_hse_convergence, TOL, MAX_ITER, dtol_fac, &
- xmin, xmax, &
- fluff_type, &
- c12_in, c12_out, o16_in, o16_out, &
- ne23_in, ne23_out, na23_in, na23_out, &
- urca_23_dens, urca_shell_type, shell_atan_kappa, &
- na_ne_23, prefix
-
-
- ! determine if we specified a runtime parameters file or use the default
- narg = command_argument_count()
-
- if (narg == 0) then
- params_file = "_params"
- else
- call get_command_argument(1, value = params_file)
- endif
-
-
- ! define the defaults parameters for this model
- nx = 1280
-
- smallx = 1.d-10
-
- xmin = 0_dp_t
- xmax = 5.d8
-
- dens_base = 2.6d9
- temp_base = 6.d8
-
- dens_conv_zone = -1.d0
- M_conv_zone = 2.0d0
-
-
- low_density_cutoff =1.d-4
- temp_fluff = 1.d7
-
- c12_in = 0.0_dp_t
- c12_out = 0.0_dp_t
- o16_in = 0.0_dp_t
- o16_out = 0.0_dp_t
- ne23_in = 0.0_dp_t
- ne23_out = 0.0_dp_t
- na23_in = 0.0_dp_t
- na23_out = 0.0_dp_t
-
- prefix = "spherical"
-
-
- ! check the namelist for any changed parameters
- open(unit=11, file=params_file, status="old", action="read")
- read(unit=11, nml=params)
- close(unit=11)
-
- ! Initialize the temperature interior to fluff
- ! (used to calculate fluff temperature for various values of fluff_type)
- temp_before_fluff = temp_fluff
-
- ! initialize the EOS and network
-
- ! use_eos_coulomb comes in from extern_probin_module -- override
- ! here if desired
- use_eos_coulomb = .true.
- call eos_init()
- call network_init()
- call actual_burner_init()
-
- ! Initialize the composition module
- call init_urca_composition()
-
-!-----------------------------------------------------------------------------
-! Create a 1-d uniform grid that is identical to the mesh that we are
-! mapping onto, and then we want to force it into HSE on that mesh.
-!-----------------------------------------------------------------------------
-
-! allocate storage
- allocate(xzn_hse(nx))
- allocate(xznl(nx))
- allocate(xznr(nx))
- allocate(model_hse(nx,nvar))
- allocate(M_enclosed(nx))
- allocate(entropy_want(nx))
- allocate(entropy_store(nx))
-
-! compute the coordinates of the new gridded function
- dCoord = (xmax - xmin) / dble(nx)
-
- do i = 1, nx
- xznl(i) = xmin + (dble(i) - 1.0_dp_t)*dCoord
- xznr(i) = xmin + (dble(i))*dCoord
- xzn_hse(i) = 0.5_dp_t*(xznl(i) + xznr(i))
- enddo
-
- fluff = .false.
-
- ! call the EOS one more time for this zone and then go on to the next
- eos_state%T = temp_base
- eos_state%rho = dens_base
- call set_urca_composition(eos_state)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- ! make the initial guess be completely uniform
- model_hse(:,idens) = eos_state%rho
- model_hse(:,itemp) = eos_state%T
- model_hse(:,ipres) = eos_state%p
-
- do i = 1, nspec
- model_hse(:,ispec-1+i) = eos_state%xn(i)
- enddo
-
- entropy_want(:) = eos_state%s
-
-
- ! keep track of the mass enclosed below the current zone
- M_enclosed(1) = FOUR3RD*M_PI*(xznr(1)**3 - xznl(1)**3)*model_hse(1,idens)
-
-
-!-----------------------------------------------------------------------------
-! HSE + entropy solve
-!-----------------------------------------------------------------------------
-
- isentropic = .true.
-
- do i = 2, nx
-
- delx = xzn_hse(i) - xzn_hse(i-1)
-
- ! as the initial guess for the temperature and density, use the previous
- ! zone
- dens_zone = model_hse(i-1,idens)
- temp_zone = model_hse(i-1,itemp)
- eos_state % rho = dens_zone
- eos_state % T = temp_zone
- call set_urca_composition(eos_state)
- eos_state % p = model_hse(i-1, ipres)
- eos_state % s = entropy_want(i)
-
- g_zone = -Gconst*M_enclosed(i-1)/(xznl(i)*xznl(i))
-
-
- !-----------------------------------------------------------------------
- ! iteration loop
- !-----------------------------------------------------------------------
-
- ! start off the Newton loop by saying that the zone has not converged
- converged_hse = .FALSE.
-
-
- if (.not. fluff) then
-
- do iretry = 1, MAX_RETRY
- try_tol = TOL*(1.1d0**(iretry-1))
- do iter = 1, MAX_ITER
- call iter_dens_temp(dens_zone, temp_zone, eos_state, &
- g_zone, delx, tol, dtol_fac, dens_conv_zone, low_density_cutoff, temp_fluff, &
- isentropic, test_hse_convergence, converged_hse, fluff, &
- fluff_type, &
- i_fluff, i_conv, i)
- if (converged_hse) then
- exit
- end if
- enddo
- if (converged_hse) then
- exit
- else if (iretry == MAX_RETRY) then
- call bl_error("ERROR: HSE non-convergence with retries!")
- end if
- enddo
-
- if (temp_zone < temp_fluff) then
- if (fluff_type .eq. "constant") then
- call get_fluff_temperature(temp_zone, temp_fluff, temp_before_fluff, fluff_type)
- endif
- isentropic = .false.
- endif
-
- else
- dens_zone = low_density_cutoff
- call get_fluff_temperature(temp_zone, temp_fluff, temp_before_fluff, fluff_type)
- endif
-
-
- ! call the EOS one more time for this zone and then go on to the next
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- call set_urca_composition(eos_state)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- ! update the thermodynamics in this zone
- model_hse(i,idens) = dens_zone
- model_hse(i,itemp) = temp_zone
- model_hse(i,ipres) = pres_zone
- do j = 1, nspec
- model_hse(i,ispec-1+j) = eos_state%xn(j)
- enddo
-
- print *, i, dens_zone, temp_zone
-
- M_enclosed(i) = M_enclosed(i-1) + &
- FOUR3RD*M_PI*(xznr(i) - xznl(i))* &
- (xznr(i)**2 +xznl(i)*xznr(i) + xznl(i)**2)*model_hse(i,idens)
-
- if (M_enclosed(i) > M_conv_zone*M_sun .and. isentropic) then
-
- i_conv = i
- isentropic = .false.
-
- endif
-
- enddo
-
-
- print *, 'mass = ', M_enclosed(nx)/M_sun
-
- write(num,'(i8)') nx
- outfile = trim(prefix) // ".hse." // trim(adjustl(num))
-
-
-
- open (unit=50, file=outfile, status="unknown")
-
- write (50,1001) "# npts = ", nx
- write (50,1001) "# num of variables = ", nvar
- write (50,1002) "# density"
- write (50,1002) "# temperature"
- write (50,1002) "# pressure"
-
- do n = 1, nspec
- write (50,1003) "# ", spec_names(n)
- enddo
-
-1000 format (1x, 12(g26.16, 1x))
-1001 format(a, i5)
-1002 format(a)
-1003 format(a,a)
-
- do i = 1, nx
-
- write (50,1000) xzn_hse(i), model_hse(i,idens), model_hse(i,itemp), model_hse(i,ipres), &
- (model_hse(i,ispec-1+n), n=1,nspec)
-
- enddo
-
-
- ! compute the maximum HSE error
- max_hse_error = -1.d30
-
- do i = 2, nx-1
- g_zone = -Gconst*M_enclosed(i-1)/xznr(i-1)**2
- dpdr = (model_hse(i,ipres) - model_hse(i-1,ipres))/delx
- rhog = HALF*(model_hse(i,idens) + model_hse(i-1,idens))*g_zone
-
- if (dpdr /= ZERO .and. model_hse(i,idens) > low_density_cutoff) then
- max_hse_error = max(max_hse_error, abs(dpdr - rhog)/abs(dpdr))
- endif
-
- if (dpdr /= 0) then
- print *, i, real(model_hse(i,idens)), real(model_hse(i,itemp)), real(dpdr), real(rhog), abs(dpdr - rhog)/abs(dpdr)
- endif
- enddo
-
- print *, 'maximum HSE error = ', max_hse_error
- print *, ' '
-
-
- print *, 'total mass (Msun) = ', M_enclosed(i_fluff)/M_sun
- print *, 'convective zone mass (Msun) = ', M_enclosed(i_conv)/M_sun
- print *, 'convective zone boundary density (g/cm^3) = ', model_hse(i_conv, idens)
- print *, 'convective zone boundary radius (cm) = ', xzn_hse(i_conv)
- print *, 'convective zone boundary index = ', i_conv
-
-
- close (unit=50)
-
-end program init_1d
-
-
-subroutine get_fluff_temperature(temp, temp_fluff, temp_previous, fluff_type)
-
- ! There are 2 kinds of fluff temperature handling:
- ! 1) fluff_type = "constant" : fluff is at the temperature temp_fluff in the inputs
- ! 2) fluff_type = "continuous" : fluff is at the same temperature as the material
- ! immediately interior to the fluff.
-
- use bl_types, only: dp_t
- use bl_error_module
-
- implicit none
-
- real (kind=dp_t), intent(out) :: temp
- real (kind=dp_t), intent(in) :: temp_fluff, temp_previous
- character (len=128), intent(in) :: fluff_type
-
- if (fluff_type .eq. "constant") then
- temp = temp_fluff
- else if (fluff_type .eq. "continuous") then
- temp = temp_previous
- else
- call bl_error("ERROR: invalid fluff_type")
- end if
-
-end subroutine get_fluff_temperature
-
-
-subroutine iter_dens_temp(dens_zone, temp_zone, eos_state_inwards, &
- g_zone, delx, tol, dtol_fac, dens_conv_zone, low_density_cutoff, temp_fluff, &
- isentropic, test_hse_convergence, converged_hse, fluff, &
- fluff_type, &
- i_fluff, i_conv, izone)
-
- ! Do one rho, T iteration
- use bl_constants_module
- use bl_types, only: dp_t
- use bl_error_module
- use eos_type_module, only: eos_t
- use eos_module, only: eos, eos_input_rt
- use urca_composition_module
-
- implicit none
-
- real (kind=dp_t), intent(inout) :: dens_zone, temp_zone
- type (eos_t), intent(in) :: eos_state_inwards
- real (kind=dp_t), intent(in) :: g_zone, dens_conv_zone, delx, tol, dtol_fac, low_density_cutoff, temp_fluff
- logical, intent(inout) :: isentropic
- logical, intent(in) :: test_hse_convergence
- logical, intent(out) :: converged_hse, fluff
- integer, intent(out) :: i_fluff, i_conv
- integer, intent(in) :: izone
- character (len=128), intent(in) :: fluff_type
-
- type (eos_t) :: eos_state
- real (kind=dp_t) :: pres_zone, entropy
- real (kind=dp_t) :: A, B, dAdT, dAdrho, dBdT, dBdrho
- real (kind=dp_t) :: dpd, dpt, dsd, dst
- real (kind=dp_t) :: p_want, drho, dtemp
- real (kind=dp_t) :: dpdr, rhog, temp_before_fluff
-
- if (isentropic) then
-
- p_want = eos_state_inwards % p + &
- delx*0.5_dp_t*(dens_zone + eos_state_inwards % rho)*g_zone
-
- ! now we have two functions to zero:
- ! A = p_want - p(rho,T)
- ! B = entropy_want - s(rho,T)
- ! We use a two dimensional Taylor expansion and find the deltas
- ! for both density and temperature
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- call set_urca_composition(eos_state)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpt = eos_state%dpdt
- dpd = eos_state%dpdr
- dst = eos_state%dsdt
- dsd = eos_state%dsdr
-
- A = p_want - pres_zone
- B = eos_state_inwards % s - entropy
-
- dAdT = -dpt
- dAdrho = 0.5d0*delx*g_zone - dpd
- dBdT = -dst
- dBdrho = -dsd
-
- dtemp = (B - (dBdrho/dAdrho)*A)/ &
- ((dBdrho/dAdrho)*dAdT - dBdT)
-
- drho = -(A + dAdT*dtemp)/dAdrho
-
- dens_zone = max((ONE-dtol_fac)*dens_zone, &
- min(dens_zone + drho, (ONE+dtol_fac)*dens_zone))
-
- temp_zone = max((ONE-dtol_fac)*temp_zone, &
- min(temp_zone + dtemp, (ONE+dtol_fac)*temp_zone))
-
-
- ! check if the density falls below our minimum cut-off --
- ! if so, floor it
- if (dens_zone < low_density_cutoff) then
-
- i_fluff = izone
-
- dens_zone = low_density_cutoff
-
- temp_before_fluff = eos_state_inwards % T
-
- call get_fluff_temperature(temp_zone, temp_fluff, temp_before_fluff, fluff_type)
-
- converged_hse = .TRUE.
- fluff = .TRUE.
- return
-
- endif
-
- if (dens_zone < dens_conv_zone .and. isentropic) then
-
- i_conv = izone
- isentropic = .false.
-
- endif
-
- if (test_hse_convergence) then
-
- ! Check to see if HSE is satisfied to relative tolerance TOL
-
- ! Call EOS again using the new values of dens_zone and temp_zone
- ! to get pres_zone ...
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- call set_urca_composition(eos_state)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! Compute dpdr
- dpdr = (pres_zone - eos_state_inwards % p)/delx
-
- ! Compute rho*g
- rhog = HALF*(dens_zone + eos_state_inwards % rho)*g_zone
-
- if (abs(dpdr - rhog) < TOL*abs(dpdr)) then
- converged_hse = .TRUE.
- return
- endif
-
- else
-
- ! Check to see if drho and dtemp are under the relative tolerance TOL
- if (abs(drho) < TOL*dens_zone .and. abs(dtemp) < TOL*temp_zone) then
- converged_hse = .TRUE.
- return
- endif
-
- endif
-
- else
-
- ! do isothermal
- p_want = eos_state_inwards % p + &
- delx*0.5*(dens_zone + eos_state_inwards % rho)*g_zone
-
- temp_zone = eos_state_inwards % T
-
-
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- call set_urca_composition(eos_state)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- entropy = eos_state%s
- pres_zone = eos_state%p
-
- dpd = eos_state%dpdr
-
- drho = (p_want - pres_zone)/(dpd - 0.5*delx*g_zone)
-
- dens_zone = max(0.9*dens_zone, &
- min(dens_zone + drho, 1.1*dens_zone))
-
- if (dens_zone < low_density_cutoff) then
-
- i_fluff = izone
-
- dens_zone = low_density_cutoff
-
- temp_before_fluff = eos_state_inwards % T
-
- call get_fluff_temperature(temp_zone, temp_fluff, temp_before_fluff, fluff_type)
-
- converged_hse = .TRUE.
- fluff = .TRUE.
- return
-
- endif
-
- if (test_hse_convergence) then
-
- ! Check to see if HSE is satisfied to relative tolerance TOL
-
- ! Call EOS again using the new values of dens_zone and temp_zone
- ! to get pres_zone ...
- eos_state%T = temp_zone
- eos_state%rho = dens_zone
- call set_urca_composition(eos_state)
-
- ! (t, rho) -> (p, s)
- call eos(eos_input_rt, eos_state)
-
- pres_zone = eos_state%p
-
- ! Compute dpdr
- dpdr = (pres_zone - eos_state_inwards % p)/delx
-
- ! Compute rho*g
- rhog = HALF*(dens_zone + eos_state_inwards % rho)*g_zone
-
- if (abs(dpdr - rhog) < TOL*abs(dpdr)) then
- converged_hse = .TRUE.
- return
- endif
-
- else
-
- ! Check to see if drho is under the relative tolerance TOL
- if (abs(drho) < TOL*dens_zone) then
- converged_hse = .TRUE.
- return
- endif
-
- endif
-
- endif
-
- ! if (.NOT. converged_hse) then
- ! print *, 'Error zone did not converge in init_1d'
- ! print *, 'integrate up'
- ! print *, 'trial density (dens_zone): ', dens_zone
- ! print *, 'trial temperature (temp_zone): ', temp_zone
- ! print *, 'current pressure (pres_zone): ', pres_zone
- ! print *, 'desired pressure (p_want): ', p_want
- ! print *, 'desired pressure rel tolerance: ', abs(pres_zone-p_want)/pres_zone
- ! print *, 'delta density (drho): ', drho
- ! print *, 'delta temperature (dtemp): ', dtemp
- ! print *, 'pressure gradient (dpdr): ', dpdr
- ! print *, 'density * gravitational accel. (rhog): ', rhog
- ! print *, 'difference... abs(dpdr-rhog): ', abs(dpdr-rhog)
- ! print *, 'target... TOL*abs(dpdr): ', TOL*abs(dpdr)
- ! call bl_error('Error: HSE non-convergence')
- ! endif
-
-end subroutine iter_dens_temp
diff --git a/Util/initial_models/urca/spherical/inputs_urca_atan b/Util/initial_models/urca/spherical/inputs_urca_atan
deleted file mode 100644
index 0425b040f..000000000
--- a/Util/initial_models/urca/spherical/inputs_urca_atan
+++ /dev/null
@@ -1,50 +0,0 @@
-&PROBIN
-
- use_eos_coulomb = T
-
-/
-
-
-¶ms
-
- nx = 2560
- dens_base = 4.5e9
- temp_base = 3.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 0.5
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- ! in/out relative to urca threshold density
- ! which atm assumes ye = 0.5 throughout
- ! O16 0.6 in - 2.5e-4, 0.5 out - 1e-4
- ! C12 0.4 in - 2.5e-4, 0.5 out - 1e-4
- ! Ne23 5e-4 in, 0 out
- ! Na23 0 in, 2e-4 out
-
- c12_in = 0.39975e0
- c12_out = 0.49990e0
- o16_in = 0.59975e0
- o16_out = 0.49990e0
- ne23_in = 5.00000e-4
- ne23_out = 0.00000e0
- na23_in = 0.00000e0
- na23_out = 2.00000e-4
-
- ! Following 0.5 Ye and Log10(rho*Ye)=8.92 from Toki+ 2013:
- urca_23_dens = 1.66e9
-
- ! Parameters controlling the species gradients near the urca shell
- urca_shell_type = "atan"
- shell_atan_kappa = 1.0d-9
-
- prefix = "WD_urca_nuc_M-0.5_hot"
-
-/
-
-
diff --git a/Util/initial_models/urca/spherical/inputs_urca_jump b/Util/initial_models/urca/spherical/inputs_urca_jump
deleted file mode 100644
index 7e7f846d9..000000000
--- a/Util/initial_models/urca/spherical/inputs_urca_jump
+++ /dev/null
@@ -1,50 +0,0 @@
-&PROBIN
-
- use_eos_coulomb = T
-
-/
-
-
-¶ms
-
- nx = 2560
- dens_base = 4.5e9
- temp_base = 3.0e8
-
- dens_conv_zone = -1.0
- M_conv_zone = 0.5
-
- low_density_cutoff = 1.e-3
- temp_fluff = 1.e7
-
- xmin = 0.0
- xmax = 5.12e8
-
- ! in/out relative to urca threshold density
- ! which atm assumes ye = 0.5 throughout
- ! O16 0.6 in - 2.5e-4, 0.5 out - 1e-4
- ! C12 0.4 in - 2.5e-4, 0.5 out - 1e-4
- ! Ne23 5e-4 in, 0 out
- ! Na23 0 in, 2e-4 out
-
- c12_in = 0.39975e0
- c12_out = 0.49990e0
- o16_in = 0.59975e0
- o16_out = 0.49990e0
- ne23_in = 5.00000e-4
- ne23_out = 0.00000e0
- na23_in = 0.00000e0
- na23_out = 2.00000e-4
-
- ! Following 0.5 Ye and Log10(rho*Ye)=8.92 from Toki+ 2013:
- urca_23_dens = 1.66e9
-
- ! Parameters controlling the species gradients near the urca shell
- urca_shell_type = "jump" ! Sharp wall. Can also choose "atan"
- shell_atan_kappa = 0.0d0 ! Use with urca_shell_type = "atan"
-
- prefix = "WD_urca_nuc_M-0.5_hot"
-
-/
-
-
diff --git a/Util/initial_models/urca/spherical/urca_composition.f90 b/Util/initial_models/urca/spherical/urca_composition.f90
deleted file mode 100644
index 0e7f4383c..000000000
--- a/Util/initial_models/urca/spherical/urca_composition.f90
+++ /dev/null
@@ -1,314 +0,0 @@
-module urca_composition_module
-
- use bl_types
- use network, only: nspec
-
- implicit none
-
- private xn_in, xn_out
- public set_urca_composition, c12_in, c12_out, o16_in, o16_out, &
- ne23_in, ne23_out, na23_in, na23_out, urca_23_dens, &
- urca_shell_type, shell_atan_kappa, na_ne_23
-
- real (kind=dp_t) :: c12_in = 0.0d0, c12_out = 0.0d0, &
- o16_in = 0.0d0, o16_out = 0.0d0, &
- ne23_in = 0.0d0, ne23_out = 0.0d0, &
- na23_in = 0.0d0, na23_out = 0.0d0, &
- urca_23_dens = 0.0d0, shell_atan_kappa = 0.0d0, &
- na_ne_23 = 0.0d0
-
- real (kind=dp_t) :: xn_in(nspec), xn_out(nspec)
-
- character (len=128) :: urca_shell_type = ""
-
-contains
-
- subroutine init_urca_composition()
- use bl_error_module
- use network, only: network_species_index
-
- implicit none
-
- integer :: ihe4, ic12, io16, ine20, ine23, ina23, img23
-
- ! get the species indices
- ihe4 = network_species_index("helium-4")
- ic12 = network_species_index("carbon-12")
- io16 = network_species_index("oxygen-16")
- ine20 = network_species_index("neon-20")
- ine23 = network_species_index("neon-23")
- ina23 = network_species_index("sodium-23")
- img23 = network_species_index("magnesium-23")
-
- ! check the required species exist
- if (ihe4 < 0 .or. &
- ic12 < 0 .or. io16 < 0 .or. ine20 < 0 .or. &
- ine23 < 0 .or. ina23 < 0 .or. img23 < 0) then
- call bl_error("ERROR: species not defined")
- endif
-
- ! check the species mass fractions
- if (c12_in < 0.0_dp_t .or. c12_in > 1.0_dp_t) then
- call bl_error("ERROR: c12_in must be between 0 and 1")
- endif
- if (c12_out < 0.0_dp_t .or. c12_out > 1.0_dp_t) then
- call bl_error("ERROR: c12_out must be between 0 and 1")
- endif
- if (o16_in < 0.0_dp_t .or. o16_in > 1.0_dp_t) then
- call bl_error("ERROR: o16_in must be between 0 and 1")
- endif
- if (o16_out < 0.0_dp_t .or. o16_out > 1.0_dp_t) then
- call bl_error("ERROR: o16_out must be between 0 and 1")
- endif
- if (ne23_in < 0.0_dp_t .or. ne23_in > 1.0_dp_t) then
- call bl_error("ERROR: ne23_in must be between 0 and 1")
- endif
- if (ne23_out < 0.0_dp_t .or. ne23_out > 1.0_dp_t) then
- call bl_error("ERROR: ne23_out must be between 0 and 1")
- endif
- if (na23_in < 0.0_dp_t .or. na23_in > 1.0_dp_t) then
- call bl_error("ERROR: na23_in must be between 0 and 1")
- endif
- if (na23_out < 0.0_dp_t .or. na23_out > 1.0_dp_t) then
- call bl_error("ERROR: na23_out must be between 0 and 1")
- endif
-
- ! Set the composition within and outside the urca shell
- ! If a non-jump profile is used at the shell, these are asymptotic
- xn_in(:) = 0.0d0
- xn_in(ic12) = c12_in
- xn_in(io16) = o16_in
- xn_in(ine23) = ne23_in
- xn_in(ina23) = na23_in
-
- xn_out(:) = 0.0d0
- xn_out(ic12) = c12_out
- xn_out(io16) = o16_out
- xn_out(ine23) = ne23_out
- xn_out(ina23) = na23_out
- end subroutine init_urca_composition
-
-
- subroutine set_urca_composition(eos_state)
-
- ! Construct composition profiles given a choice of
- ! the type of profile denoted by urca_shell_type.
- ! "jump": impose sharp species discontinuity
- ! "atan": use arctan to smooth composition profile
- use bl_error_module
- use bl_types, only: dp_t
- use network
- use eos_type_module, only: eos_t
-
- type (eos_t), intent(inout) :: eos_state
-
- if (urca_shell_type .eq. "jump") then
- call composition_jump(eos_state, urca_23_dens, xn_in, xn_out)
- else if (urca_shell_type .eq. "atan") then
- call composition_atan(eos_state, urca_23_dens, xn_in, xn_out, shell_atan_kappa)
- else if (urca_shell_type .eq. "equilibrium") then
- call composition_equilibrium(eos_state)
- else
- call bl_error("ERROR: invalid urca_shell_type")
- end if
-
- ! Floor species so abundances below 1E-30 are 0.0d0
- call floor_species(eos_state)
-
- ! Renormalize species
- call renormalize_species(eos_state)
-
- end subroutine set_urca_composition
-
-
- subroutine floor_species(eos_state)
-
- ! Species mass fractions below 1E-30 should just be 0.0
- ! This prevents getting abundances of ~1E-100. Note that
- ! the initial model writing omits the "E" in the exponent
- ! if the exponent requires 3 digits.
- use bl_constants_module, only: ZERO
- use bl_types, only: dp_t
- use eos_type_module, only: eos_t
- use network, only: nspec
-
- type (eos_t), intent(inout) :: eos_state
- real (kind=dp_t), parameter :: mass_fraction_floor = 1.0d-30
- integer :: i
-
- do i = 1, nspec
- if (eos_state % xn(i) < mass_fraction_floor) then
- eos_state % xn(i) = ZERO
- end if
- end do
-
- end subroutine floor_species
-
-
- subroutine renormalize_species(eos_state)
-
- ! Renormalize the mass fractions so they sum to 1
- use bl_types, only: dp_t
- use eos_type_module, only: eos_t
-
- type (eos_t), intent(inout) :: eos_state
- real (kind=dp_t) :: sumx
-
- sumx = sum(eos_state % xn)
- eos_state % xn(:) = eos_state % xn(:)/sumx
-
- end subroutine renormalize_species
-
-
- subroutine composition_jump(eos_state, shell_rho, xn_left, xn_right)
- use bl_types
- use bl_constants_module, only: HALF
- use network
- use eos_type_module, only: eos_t
-
- type (eos_t), intent(inout) :: eos_state
- real (kind=dp_t), intent( in) :: shell_rho
- real (kind=dp_t), intent( in), dimension(nspec) :: xn_left, xn_right
-
- if (eos_state % rho < shell_rho) then
- eos_state % xn = xn_right
- else if (eos_state % rho > shell_rho) then
- eos_state % xn = xn_left
- else
- eos_state % xn = HALF*(xn_right + xn_left)
- end if
- end subroutine composition_jump
-
-
- subroutine composition_atan(eos_state, shell_rho, xn_left, xn_right, &
- shell_atan_kappa)
- use bl_types
- use bl_constants_module, only: TWO, HALF, M_PI
- use network
- use eos_type_module, only: eos_t
-
- type (eos_t), intent(inout) :: eos_state
- real (kind=dp_t), intent(in) :: shell_rho, shell_atan_kappa
- real (kind=dp_t), intent(in), dimension(nspec) :: xn_left, xn_right
- real (kind=dp_t), dimension(nspec) :: A, B
-
- B = HALF * (xn_left + xn_right)
- A = xn_right - B
-
- eos_state % xn = (TWO/M_PI) * A * atan(shell_atan_kappa * (shell_rho - eos_state % rho)) + B
- end subroutine composition_atan
-
-
- subroutine composition_equilibrium(eos_state)
-
- use bl_types
- use bl_constants_module, only: ZERO, HALF, ONE
- use bl_error_module, only: bl_error
- use network
- use actual_network, only: k_na23_ne23, k_ne23_na23
- use actual_rhs_module, only: rate_eval_t, evaluate_rates
- use eos_type_module, only: eos_t, composition
- use burn_type_module, only: burn_t, eos_to_burn
-
- implicit none
-
- type (eos_t), intent(inout) :: eos_state
- type (burn_t) :: burn_state
- double precision :: fopt, r_ecap, r_beta, dx
- double precision, parameter :: rate_equilibrium_tol = 1.0e-10
- integer, parameter :: max_equilibrium_iters = 10000
- type (rate_eval_t) :: rate_eval
-
- ! Get some mass fraction indices
- integer :: ic12, io16, ine23, ina23, j
-
- ! get the species indices
- ic12 = network_species_index("carbon-12")
- io16 = network_species_index("oxygen-16")
- ine23 = network_species_index("neon-23")
- ina23 = network_species_index("sodium-23")
-
- ! Initialize mass fractions given "in" values
- eos_state % xn(:) = 0.0d0
- eos_state % xn(ic12) = c12_in
- eos_state % xn(io16) = o16_in
- eos_state % xn(ine23) = HALF * na_ne_23
- eos_state % xn(ina23) = HALF * na_ne_23
-
- ! Estimate the mass fractions approximating the rates as
- ! independent of ye.
- call composition(eos_state)
- call eos_to_burn(eos_state, burn_state)
- call evaluate_rates(burn_state, rate_eval)
-
- r_ecap = rate_eval % screened_rates(k_na23_ne23)
- r_beta = rate_eval % screened_rates(k_ne23_na23)
-
- eos_state % xn(ine23) = na_ne_23/(ONE + r_beta/r_ecap)
- eos_state % xn(ina23) = na_ne_23 - eos_state % xn(ine23)
-
- ! Keep the mass fraction sum X(ne23) + X(na23) = na_ne_23
- ! Find the A=23 mass fractions such that A=23 Urca rates are in equilibrium
- ! Do Newton iterations approximating the rates as independent of mass fraction
- call fopt_urca_23(eos_state, fopt, r_ecap, r_beta)
-! write(*,*) 'fopt = ', fopt
- j = 1
- do while (abs(fopt) > rate_equilibrium_tol .and. j < max_equilibrium_iters)
-! write(*,*) 'iteration ', j, ' fopt = ', fopt
- dx = -fopt/(r_ecap + r_beta)
- if (fopt > ZERO) then
- eos_state % xn(ina23) = eos_state % xn(ina23) + dx
- eos_state % xn(ine23) = na_ne_23 - eos_state % xn(ina23)
- call fopt_urca_23(eos_state, fopt, r_ecap, r_beta)
- else
- eos_state % xn(ine23) = eos_state % xn(ine23) - dx
- eos_state % xn(ina23) = na_ne_23 - eos_state % xn(ine23)
- call fopt_urca_23(eos_state, fopt, r_ecap, r_beta)
- end if
- j = j + 1
-! write(*,*) 'xn = ', eos_state % xn
- end do
-
- if (j == max_equilibrium_iters) then
- call bl_error("species iteration did not converge!")
- end if
-
- end subroutine composition_equilibrium
-
-
- subroutine fopt_urca_23(eos_state, fopt, r_ecap, r_beta)
-
- use bl_constants_module, only: HALF
- use eos_type_module, only: eos_t, composition
- use network
- use actual_network, only: k_na23_ne23, k_ne23_na23
- use actual_rhs_module, only: rate_eval_t, evaluate_rates
- use burn_type_module, only: burn_t, eos_to_burn
-
- implicit none
-
- type (eos_t), intent(inout) :: eos_state
- double precision, intent(out) :: fopt, r_ecap, r_beta
- double precision :: xr_ecap, xr_beta
- integer :: ine23, ina23
- type (burn_t) :: burn_state
- type (rate_eval_t) :: rate_eval
-
- ine23 = network_species_index("neon-23")
- ina23 = network_species_index("sodium-23")
-
- call composition(eos_state)
- call eos_to_burn(eos_state, burn_state)
- call evaluate_rates(burn_state, rate_eval)
-
- r_ecap = rate_eval % screened_rates(k_na23_ne23)
- r_beta = rate_eval % screened_rates(k_ne23_na23)
-
- xr_ecap = burn_state % xn(ina23) * r_ecap
- xr_beta = burn_state % xn(ine23) * r_beta
-
- fopt = xr_ecap - xr_beta
-
- end subroutine fopt_urca_23
-
-end module urca_composition_module