In [36]:
%matplotlib inline
%load_ext autoreload
%autoreload 2

from __future__ import (division, 
                        print_function)

## ---------------------------------------------------------------------------------------------##
## Imports
## ---------------------------------------------------------------------------------------------##
import os
import sys
import copy
import fnmatch
import warnings
import collections

## ---------------------------------------------------------------------------------------------##
import numpy as np
import scipy
try:
    from scipy.stats import scoreatpercentile
except:
    scoreatpercentile = False
from scipy.interpolate import interp1d
import scipy.ndimage as ndimage

import cPickle as pickle

## ---------------------------------------------------------------------------------------------##
# Astropy
from astropy.io import fits 
from astropy import wcs
from astropy import units as u
from astropy.table import Table, Column, vstack
from astropy.stats import sigma_clip
from astropy.nddata import Cutout2D
from astropy.utils.console import ProgressBar
from astropy import coordinates as coords
from astropy.stats import sigma_clip
from astropy.convolution import convolve, Box1DKernel

## ---------------------------------------------------------------------------------------------##
# AstroML
from astroML.plotting import hist
from astroML.density_estimation import KNeighborsDensity
try:
    from sklearn.neighbors import KernelDensity
    use_sklearn_KDE = True
except:
    import warnings
    warnings.warn("KDE will be removed in astroML version 0.3.  Please "
                  "upgrade to scikit-learn 0.14+ and use "
                  "sklearn.neighbors.KernelDensity.", DeprecationWarning)
    from astroML.density_estimation import KDE
    use_sklearn_KDE = False
from sklearn.neighbors import KDTree
from sklearn.neighbors import BallTree

## ---------------------------------------------------------------------------------------------##
# Matplotlib related
import matplotlib.pyplot as plt
import matplotlib.patches as mpatches
from matplotlib.patches import Ellipse
from matplotlib.ticker import NullFormatter, MaxNLocator, FormatStrFormatter
from matplotlib.collections import PatchCollection
tickFormat = FormatStrFormatter('$\mathbf{%g}$') 
mpl.style.use('classic')

## ---------------------------------------------------------------------------------------------##
# Cosmology
import cosmology
c=cosmology.Cosmo(H0=70.0, omega_m=0.3, omega_l=0.7, flat=1)

## ---------------------------------------------------------------------------------------------##
# Color map 
from palettable.colorbrewer.sequential import Greys_9, OrRd_9, Blues_9, Purples_9, YlGn_9
BLK = Greys_9.mpl_colormap
ORG = OrRd_9.mpl_colormap
BLU = Blues_9.mpl_colormap
GRN = YlGn_9.mpl_colormap
PUR = Purples_9.mpl_colormap

## ---------------------------------------------------------------------------------------------##
# Define the region of interests: 
from shapely.geometry import Polygon, Point
from descartes import PolygonPatch

## ---------------------------------------------------------------------------------------------##
# Emcee
import emcee
import corner

## ---------------------------------------------------------------------------------------------##
# Personal
import hscUtils as hUtil
import coaddCutoutGalfitSimple as gSimple 
from hscUtils import songPlotSetup, removeIsNullCol
from hscUtils import confidence_interval, ma_confidence_interval_1d, confidence_interval_1d

## ---------------------------------------------------------------------------------------------##
## Constants
## ---------------------------------------------------------------------------------------------##
# SDSS pivot wavelength 
SDSS_U_PIVOT = 3551.0
SDSS_G_PIVOT = 4686.0
SDSS_R_PIVOT = 6165.0
SDSS_I_PIVOT = 7481.0
SDSS_Z_PIVOT = 8931.0

# HSC pivot wavelength 
HSC_G_PIVOT = 4782.2
HSC_R_PIVOT = 6101.7 
HSC_I_PIVOT = 7648.0 
HSC_Z_PIVOT = 8883.0
HSC_Y_PIVOT = 9750.8

# Extinction correction factor for HSC 
## A\_lambda = Coeff * E(B-V) 
A_HSC_G = 3.233
A_HSC_R = 2.291 
A_HSC_I = 1.635
A_HSC_Z = 1.261
A_HSC_Y = 1.076

A_G = 0.528
A_I = 0.260
hscFiltWave = np.asarray([HSC_G_PIVOT, HSC_R_PIVOT, HSC_I_PIVOT, HSC_Z_PIVOT, HSC_Y_PIVOT])

## ---------------------------------------------------------------------------------------------##
"""
Absolute magnitude of the Sun in HSC filters
Right now, just use the DES filters
"""
SUN_G = 5.08
SUN_R = 4.62
SUN_I = 4.52
SUN_Z = 4.52
SUN_Y = 4.51

# Solar stellar metallicity 
Z_SUN = 0.02

## ---------------------------------------------------------------------------------------------##
# definitions for the axes
RECSCAT = [0.16, 0.11, 0.59, 0.88]
RECHIST = [0.75, 0.11, 0.24, 0.88]
SBP1 = [0.13, 0.12, 0.865, 0.30]
SBP2 = [0.13, 0.42, 0.865, 0.54]
EC1 = [0.135, 0.066, 0.862, 0.30]
EC2 = [0.135, 0.366, 0.862, 0.30]
EC3 = [0.135, 0.666, 0.862, 0.30]
REC = [0.12, 0.11, 0.87, 0.87]
COG1 = [0.143, 0.10, 0.850, 0.43]
COG2 = [0.143, 0.53, 0.850, 0.43]

## ---------------------------------------------------------------------------------------------##
# Color 
BLUE0 = "#92c5de"
BLUE1 = "#0571b0"
RED0 = "#f4a582"
RED1 = "#ca0020"
PURPLE0 = '#af8dc3'
PURPLE1 = '#762a83'
BROWN0 = '#bf812d'
BROWN1 = '#543005'
GREEN0 = '#7fbf7b'
GREEN1 = '#1b7837'

## ---------------------------------------------------------------------------------------------##
# 3-sigma
SIGMA1 = 0.3173
SIGMA2 = 0.0455
SIGMA3 = 0.0027
## ---------------------------------------------------------------------------------------------##


The autoreload extension is already loaded. To reload it, use:
  %reload_ext autoreload

In [4]:
def getExtinction(ra, dec, a_lambda=None):
    """
    Estimate the Galactic extinction for HSC filters.

    Parameters:
        ra, dec : The input coordinates can be arrays
    """
    # First try mwdust from Jo Bovy
    try:
        import mwdust
        sfd = mwdust.SFD(sf10=True)

        from astropy.coordinates import SkyCoord
        coords = SkyCoord(ra, dec, frame='icrs', unit='deg')
        galactic = coords.galactic
        l, b = galactic.l, galactic.b
        ebv = sfd(l, b, 0)
    except ImportError:
        try:
            # Then try sncosmo
            from sncosmo import SFD98Map
            dustDir = os.environ.get('DUST_DIR')
            if (not os.path.isfile(os.path.join(dustDir,
                                   'SFD_dust_4096_ngp.fits'))) or (
                not os.path.isfile(os.path.join(dustDir,
                                   'SFD_dust_4096_sgp.fits'))):
                print('# DUST_DIR : %s' % dustDir)
                raise Exception("# Can not find the SFD dust map!")
            else:
                sfd = SFD98Map(dustDir)
                ebv = sfd.get_ebv((ra, dec))
        except ImportError:
            raise Exception("# Both mwdust and sncosmo are not available")
    if a_lambda is not None:
        return (ebv * a_lambda)
    else:
        return ebv
    
    
def zscale(img, contrast=0.25, samples=500):
    """
    Imaging scaling function. 
    
    Parameters: 
        contrast  : 
        samples   :
    """
    ravel = img.ravel()
    if len(ravel) > samples:
        imsort = np.sort(np.random.choice(ravel, size=samples))
    else:
        imsort = np.sort(ravel)

    n = len(imsort)
    idx = np.arange(n)

    med = imsort[n/2]
    w = 0.25
    i_lo, i_hi = int((0.5 - w) * n), int((0.5 + w) * n)
    p = np.polyfit(idx[i_lo:i_hi], imsort[i_lo:i_hi], 1)
    slope, intercept = p

    z1 = med - (slope/contrast)*(n/2-n*w)
    z2 = med + (slope/contrast)*(n/2-n*w)

    return z1, z2

def toColorArr(data, bottom=None, top=None):
    """ 
    Convert a data array to "color array" (between 0 and 1). 
    
    Parameters:
        bottom, top  : 
    """
    if top is not None:
        data[data >= top]    = top
    if bottom is not None:
        data[data <= bottom] = bottom
        
    return ((data - np.nanmin(data)) / 
            (np.nanmax(data) - np.nanmin(data))) * 255.0

Basic information


In [5]:
# redshift of Perseus cluster 
z_per = 0.017900

# Pixel scale 
pix = 0.168
asecScale = 0.366 
scale = (asecScale * pix) * u.kpc

# R200 x 0.1 
rCluster = (180.0 / asecScale) / 3600.0

# Number of pixels for 1 Kpc at the distance of Perseus
kpcPix = (1.0 / scale)

# Boundary of the useful data
raLow, raUpp = 48.9, 51.0
decLow, decUpp = 40.7, 42.3

# Distance module (error is about 0.15 mag)
distMod = 34.36 
cosDim = 0.07332 

print("At z=%6.4f, 1 HSC pixel (%5.3f arcsec) equals to %5.3f Kpc" % (z_per, pix, scale.value))
print(" 1 Kpc == %5.3f pixels" % kpcPix.value)
print(" 0.1 x R200 ~ 180 Kpc ~ %6.3f" % rCluster)

print(
"""
# NGC 1272 
Cosmology-Corrected Quantities [Ho =  70.50 km/sec/Mpc, Ωmatter =   0.27, Ωvacuum =   0.73]
[Redshift 0.012577 as corrected to the Reference Frame defined by the (Virgo + GA + Shapley)]
Luminosity Distance        : 54 Mpc      (m-M) = 33.66 mag
Angular-Size Distance      : 52.7 Mpc      (m-M) = 33.61 mag
Co-Moving Radial Distance  : 53.3 Mpc      (m-M) = 33.64 mag
Co-Moving Tangential Dist. : 53.3 Mpc      (m-M) = 33.64 mag
Co-Moving Volume           : 0.000636 Gpc^3
Light Travel-Time          :    0.173 Gyr
Age at Redshift 0.012577   :   13.598 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     255 pc/arcsec =  0.255 kpc/arcsec =  15.32 kpc/arcmin =   0.92 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.95124; Magnitude per Unit Area = 0.05428 mag""")


print(
"""
# NGC 1275
Luminosity Distance        : 74.4 Mpc      (m-M) = 34.36 mag
Angular-Size Distance      : 71.9 Mpc      (m-M) = 34.28 mag
Co-Moving Radial Distance  : 73.2 Mpc      (m-M) = 34.32 mag
Co-Moving Tangential Dist. : 73.2 Mpc      (m-M) = 34.32 mag
Co-Moving Volume           : 0.00164 Gpc^3
Light Travel-Time          :    0.237 Gyr
Age at Redshift 0.017264   :   13.534 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     349 pc/arcsec =  0.349 kpc/arcsec =  20.92 kpc/arcmin =   1.26 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.93382; Magnitude per Unit Area = 0.07434 mag"""
)

print(
"""
# NGC 1277
[Redshift 0.016622 as corrected to the Reference Frame defined by the (Virgo + GA + Shapley)]
Luminosity Distance        : 71.6 Mpc      (m-M) = 34.27 mag
Angular-Size Distance      : 69.3 Mpc      (m-M) = 34.20 mag
Co-Moving Radial Distance  : 70.4 Mpc      (m-M) = 34.24 mag
Co-Moving Tangential Dist. : 70.4 Mpc      (m-M) = 34.24 mag
Co-Moving Volume           : 0.00146 Gpc^3
Light Travel-Time          :    0.228 Gyr
Age at Redshift 0.016622   :   13.543 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     336 pc/arcsec =  0.336 kpc/arcsec =  20.16 kpc/arcmin =   1.21 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.93619; Magnitude per Unit Area = 0.07159 mag
"""
)

print(
"""
# NGC 1278 
[Redshift 0.019954 as corrected to the Reference Frame defined by the (Virgo + GA + Shapley)]
Luminosity Distance        : 86.2 Mpc      (m-M) = 34.68 mag
Angular-Size Distance      : 82.9 Mpc      (m-M) = 34.59 mag
Co-Moving Radial Distance  : 84.5 Mpc      (m-M) = 34.63 mag
Co-Moving Tangential Dist. : 84.5 Mpc      (m-M) = 34.63 mag
Co-Moving Volume           : 0.00253 Gpc^3
Light Travel-Time          :    0.273 Gyr
Age at Redshift 0.019954   :   13.498 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     402 pc/arcsec =  0.402 kpc/arcsec =  24.10 kpc/arcmin =   1.45 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.92401; Magnitude per Unit Area = 0.08581 mag
"""
)

distMod1, asec1 = 34.68, 0.402 
distMod2, asec2 = 33.66, 0.255 
scale1 = (asec1 * pix) * u.kpc
scale2 = (asec2 * pix) * u.kpc

print(scale1, scale2)


At z=0.0179, 1 HSC pixel (0.168 arcsec) equals to 0.061 Kpc
 1 Kpc == 16.263 pixels
 0.1 x R200 ~ 180 Kpc ~  0.137

# NGC 1272 
Cosmology-Corrected Quantities [Ho =  70.50 km/sec/Mpc, Ωmatter =   0.27, Ωvacuum =   0.73]
[Redshift 0.012577 as corrected to the Reference Frame defined by the (Virgo + GA + Shapley)]
Luminosity Distance        : 54 Mpc      (m-M) = 33.66 mag
Angular-Size Distance      : 52.7 Mpc      (m-M) = 33.61 mag
Co-Moving Radial Distance  : 53.3 Mpc      (m-M) = 33.64 mag
Co-Moving Tangential Dist. : 53.3 Mpc      (m-M) = 33.64 mag
Co-Moving Volume           : 0.000636 Gpc^3
Light Travel-Time          :    0.173 Gyr
Age at Redshift 0.012577   :   13.598 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     255 pc/arcsec =  0.255 kpc/arcsec =  15.32 kpc/arcmin =   0.92 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.95124; Magnitude per Unit Area = 0.05428 mag

# NGC 1275
Luminosity Distance        : 74.4 Mpc      (m-M) = 34.36 mag
Angular-Size Distance      : 71.9 Mpc      (m-M) = 34.28 mag
Co-Moving Radial Distance  : 73.2 Mpc      (m-M) = 34.32 mag
Co-Moving Tangential Dist. : 73.2 Mpc      (m-M) = 34.32 mag
Co-Moving Volume           : 0.00164 Gpc^3
Light Travel-Time          :    0.237 Gyr
Age at Redshift 0.017264   :   13.534 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     349 pc/arcsec =  0.349 kpc/arcsec =  20.92 kpc/arcmin =   1.26 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.93382; Magnitude per Unit Area = 0.07434 mag

# NGC 1277
[Redshift 0.016622 as corrected to the Reference Frame defined by the (Virgo + GA + Shapley)]
Luminosity Distance        : 71.6 Mpc      (m-M) = 34.27 mag
Angular-Size Distance      : 69.3 Mpc      (m-M) = 34.20 mag
Co-Moving Radial Distance  : 70.4 Mpc      (m-M) = 34.24 mag
Co-Moving Tangential Dist. : 70.4 Mpc      (m-M) = 34.24 mag
Co-Moving Volume           : 0.00146 Gpc^3
Light Travel-Time          :    0.228 Gyr
Age at Redshift 0.016622   :   13.543 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     336 pc/arcsec =  0.336 kpc/arcsec =  20.16 kpc/arcmin =   1.21 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.93619; Magnitude per Unit Area = 0.07159 mag


# NGC 1278 
[Redshift 0.019954 as corrected to the Reference Frame defined by the (Virgo + GA + Shapley)]
Luminosity Distance        : 86.2 Mpc      (m-M) = 34.68 mag
Angular-Size Distance      : 82.9 Mpc      (m-M) = 34.59 mag
Co-Moving Radial Distance  : 84.5 Mpc      (m-M) = 34.63 mag
Co-Moving Tangential Dist. : 84.5 Mpc      (m-M) = 34.63 mag
Co-Moving Volume           : 0.00253 Gpc^3
Light Travel-Time          :    0.273 Gyr
Age at Redshift 0.019954   :   13.498 Gyr
Age of Universe            :   13.770 Gyr
Scale (Cosmology Corrected):     402 pc/arcsec =  0.402 kpc/arcsec =  24.10 kpc/arcmin =   1.45 Mpc/degree
Surface Brightness Dimming : Flux Density per Unit Area =  0.92401; Magnitude per Unit Area = 0.08581 mag

0.067536 kpc 0.04284 kpc

Summarize the results of UDG GALFIT run


In [6]:
loc = '/Users/songhuang/work/project/perseus/final/i/'

expMod = glob.glob(loc + '*_exp.fits')
serMod = glob.glob(loc + '*_ser.fits')

print(len(expMod))
print(len(serMod))


504
505

In [40]:
expMag, expRe, expAr, expNser = [], [], [], []
expChi2, expNdof, expRchi2 = [], [], []

for modFile in expMod:
    #try: 
    mod = gPar.GalfitResults(modFile, verbose=False)
    #except Exception:
    #    continue 
    
    nComp = mod.num_components
    
    for ii in range(nComp):
        icomp = (ii + 1)
        strComp = '_'.join(['component', str(icomp).strip()])
        comp = getattr(mod, strComp)
        
        if comp.component_type == 'sersic':
            expChi2.append(mod.chisq)
            expNdof.append(mod.ndof)
            expRchi2.append(mod.reduced_chisq)
            
            expMag.append(comp.mag)
            expRe.append(comp.re)
            expAr.append(comp.ar)
            expNser.append(comp.n)
        else:
            continue

In [41]:
expRchi2


Out[41]:
[0.9298409,
 0.9217039,
 0.864949,
 0.7778444,
 0.9111869,
 0.7589391,
 0.9711802,
 0.7016214,
 0.8572797,
 0.8529894,
 0.9687716,
 0.8728211,
 0.934666,
 0.6772792,
 0.8227792,
 2.19696,
 0.9011043,
 0.9096255,
 0.8832299,
 0.8474214,
 0.8669114,
 0.8871246,
 0.7962385,
 1.04774,
 0.6179622,
 0.7169403,
 0.8521931,
 0.7822645,
 1.000904,
 0.9145163,
 0.8605185,
 0.9240429,
 0.9907457,
 0.9254876,
 1.587738,
 0.886668,
 0.8352768,
 1.006364,
 0.765451,
 0.9002748,
 1.104656,
 0.9403037,
 0.8777341,
 0.806742,
 0.8799615,
 1.024465,
 1.206204,
 0.8767992,
 0.9189786,
 0.7974243,
 1.145559,
 0.8423942,
 1.049186,
 0.8391333,
 0.7496963,
 0.8712605,
 0.8064191,
 0.7830353,
 0.871918,
 0.8772998,
 2.146867,
 0.9317676,
 1.657458,
 0.9452422,
 0.8088181,
 0.8148372,
 0.8141681,
 0.841798,
 0.7152041,
 0.8742645,
 0.8995164,
 0.7500538,
 0.5665862,
 0.9883419,
 0.9605625,
 0.9033707,
 0.8137543,
 0.8916285,
 1.486977,
 0.9448273,
 0.8866906,
 0.893633,
 0.7334853,
 0.9630495,
 0.8549702,
 0.8970403,
 0.8107827,
 0.9073451,
 0.7700029,
 1.51329,
 0.8889893,
 0.818205,
 0.7111931,
 0.8385723,
 0.879625,
 1.279477,
 0.8700452,
 0.9383119,
 0.8294727,
 0.9167663,
 0.763778,
 0.9078342,
 0.8383716,
 0.8742095,
 0.8625082,
 0.7147469,
 0.8475775,
 0.9234643,
 0.8564013,
 0.9421144,
 1.340416,
 1.514459,
 0.7942989,
 0.9492368,
 0.8542043,
 0.851274,
 0.7301137,
 0.6227958,
 0.8490024,
 0.7293405,
 0.7890325,
 0.955706,
 0.9217884,
 0.7663742,
 0.8335745,
 0.9764135,
 1.049352,
 0.8725557,
 0.8854791,
 0.8976401,
 1.456443,
 0.9064415,
 0.8348632,
 1.081122,
 0.9171069,
 1.102072,
 2.330193,
 0.855697,
 0.9018366,
 0.5053263,
 0.8881962,
 0.8354275,
 0.9541419,
 0.7184366,
 0.8494286,
 2.716452,
 1.397378,
 0.808345,
 0.944796,
 0.7210116,
 3.495237,
 2.176823,
 0.8306246,
 0.9068465,
 0.9438535,
 0.7995383,
 0.8465244,
 0.8439325,
 0.8867401,
 0.8569665,
 1.088921,
 0.9026937,
 0.7986832,
 0.9014499,
 1.43914,
 0.7926698,
 0.7667627,
 0.937055,
 0.8547219,
 0.9094896,
 0.8521443,
 0.8533764,
 0.7814549,
 0.7265729,
 0.7816283,
 1.384722,
 0.812086,
 1.029609,
 2.497259,
 0.6734608,
 0.782827,
 0.8585213,
 0.7753735,
 0.8649752,
 0.8273372,
 1.064163,
 0.8705443,
 1.969335,
 0.9734188,
 0.8042796,
 0.8563036,
 0.8087536,
 0.8448281,
 0.9837049,
 0.7132609,
 1.272967,
 0.8839045,
 0.8083885,
 0.7519796,
 1.256064,
 0.8563959,
 0.7567986,
 0.7262211,
 0.8484714,
 0.8080884,
 0.7729116,
 1.285471,
 0.8523699,
 0.9158822,
 0.8104309,
 0.6939381,
 0.8647459,
 1.043838,
 0.3885815,
 1.224619,
 0.9378463,
 0.9210547,
 0.7810863,
 0.7458668,
 0.9379807,
 0.8480462,
 0.8138767,
 0.879758,
 0.9473968,
 1.057991,
 0.9144602,
 0.8421506,
 0.9404458,
 0.8883718,
 1.114228,
 0.8603687,
 0.8292488,
 0.8790507,
 0.7395234,
 0.8807886,
 1.654653,
 1.152397,
 0.8516804,
 0.8496006,
 1.244339,
 1.218978,
 0.8539932,
 0.8293536,
 1.054289,
 0.8569396,
 0.9594565,
 0.9833824,
 0.9180269,
 0.9441828,
 0.8328066,
 0.8561796,
 0.8708114,
 0.7684851,
 0.9259723,
 1.149463,
 0.7435939,
 0.8542435,
 1.856935,
 0.842883,
 0.8100652,
 0.7989979,
 0.8750615,
 0.6886303,
 0.8035401,
 0.901573,
 0.9648675,
 0.9035687,
 0.8471364,
 2.689583,
 1.052993,
 0.8691599,
 0.8559585,
 0.9948229,
 0.8622138,
 0.9288576,
 1.931958,
 0.7226678,
 0.95763,
 1.246234,
 0.7480415,
 0.8940299,
 0.9248925,
 0.7500724,
 0.716154,
 0.8674362,
 0.8972437,
 0.7320368,
 0.9690724,
 0.8564411,
 0.8383188,
 0.7920124,
 0.8829085,
 0.8853605,
 0.873633,
 0.8495132,
 0.8890579,
 1.0923,
 0.8648193,
 0.8183464,
 0.913035,
 1.154735,
 0.8085765,
 0.8360285,
 0.8452326,
 0.7541676,
 0.7728907,
 0.859149,
 0.7319661,
 0.9116899,
 0.7876872,
 0.5996253,
 1.436275,
 0.9765463,
 0.8151891,
 2.831239,
 0.7849481,
 1.010681,
 0.8465312,
 1.347133,
 0.9697971,
 0.7646244,
 0.8842108,
 0.8860806,
 0.8553042,
 0.8019623,
 0.8633163,
 0.7923231,
 0.8698974,
 0.8661213,
 1.054257,
 0.7845383,
 0.7884877,
 0.9609976,
 0.8627435,
 0.9109192,
 0.8505181,
 0.9015546,
 0.9069282,
 0.752826,
 0.8506984,
 0.9283612,
 0.8751047,
 0.9282883,
 0.8094447,
 0.9223923,
 0.9723768,
 0.8713609,
 0.9200139,
 0.8929254,
 0.8239707,
 0.8574421,
 0.8004927,
 0.8502035,
 0.7988927,
 0.7826363,
 0.8415084,
 0.8906118,
 0.8593032,
 0.7986033,
 0.8069426,
 0.8490289,
 0.8628957,
 0.9593604,
 0.8539293,
 0.9546944,
 0.9181288,
 0.7751672,
 0.8386387,
 0.8541398,
 0.7685282,
 0.7830607,
 0.7689241,
 0.9099507,
 0.9013473,
 0.8227997,
 0.7683988,
 0.8225831,
 0.9975177,
 0.8082619,
 0.6308697,
 0.9865816,
 0.7710605,
 0.9124992,
 0.9944223,
 0.9443937,
 0.9086014,
 0.8857391,
 0.9209399,
 0.8459722,
 0.9316732,
 0.9999277,
 0.8896924,
 0.8594565,
 0.8555271,
 0.9336621,
 0.8887925,
 0.8936346,
 0.9026647,
 0.9028994,
 0.8573823,
 0.8915278,
 0.8061513,
 0.9709598,
 0.9396163,
 0.8486079,
 0.8691018,
 0.8183284,
 0.9892974,
 0.8318103,
 0.873937,
 0.9672012,
 0.90787,
 0.8525822,
 0.861551,
 0.8214961,
 0.4072372,
 0.9056247,
 0.9311171,
 0.949476,
 0.9089819,
 0.8985921,
 0.8407044,
 0.8835918,
 0.7490563,
 0.8987777,
 0.9291432,
 0.8341925,
 1.124215,
 0.8957074,
 0.5909593,
 1.000797,
 1.164515,
 1.069642,
 0.9262738,
 0.9459382,
 1.306266,
 0.9745153,
 0.7893133,
 1.592528,
 0.9886405,
 1.002459,
 0.9023034,
 0.8557117,
 1.17678,
 0.8496798,
 0.8650398,
 0.8943575,
 0.9811181,
 0.8908145,
 0.8638799,
 1.209055,
 0.9477394,
 0.8426467,
 0.9216045,
 0.9686207,
 0.7855433,
 1.079472,
 0.8852201,
 0.8393161,
 0.9112978,
 0.8894633,
 0.9363363,
 0.8481309,
 0.8404493,
 0.7764714,
 0.873062,
 0.8258675,
 0.9075047,
 0.9282231,
 0.9229868,
 0.8899982,
 0.9257892,
 0.766239,
 1.001637,
 0.882964,
 1.001124,
 0.9024947,
 0.893784,
 0.8766044,
 0.9201139,
 0.815591,
 0.8661863,
 0.9421406,
 0.8789521,
 0.8816416,
 0.8865052,
 1.300827,
 0.9080344,
 0.8881679,
 1.151554,
 0.69697,
 1.095439,
 0.81265,
 0.8418816,
 1.042771,
 0.762935,
 0.9804254,
 0.8771427,
 0.8790096,
 0.7645949,
 0.9760697,
 0.82631,
 0.9668801,
 0.8968706]