diff --git a/.github/workflows/ci.yml b/.github/workflows/ci.yml index 6e294f742..37d0e94a5 100644 --- a/.github/workflows/ci.yml +++ b/.github/workflows/ci.yml @@ -40,52 +40,64 @@ jobs: ${{ runner.os }}-test-${{ env.cache-name }}- ${{ runner.os }}-test- ${{ runner.os }}- - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRIBase: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRIBase - - name: "Run tests for KomaMRIBase" - if: always() + - name: "KomaMRIBase: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRIBase - - name: "KomaMRICore dev setup" + - name: "KomaMRICore: Development Setup" + if: '!cancelled()' shell: bash run: | julia --color=yes --project="KomaMRICore" -e "using Pkg; Pkg.develop(PackageSpec(; path=\"./KomaMRIBase\"));" - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRICore: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRICore - - name: "Run tests for KomaMRICore" - if: always() + - name: "KomaMRICore: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRICore - - name: "KomaMRIFiles dev setup" + - name: "KomaMRIFiles: Development Setup" + if: '!cancelled()' shell: bash run: | julia --color=yes --project="KomaMRIFiles" -e "using Pkg; Pkg.develop(PackageSpec(; path=\"./KomaMRIBase\"));" - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRIFiles: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRIFiles - - name: "Run tests for KomaMRIFiles" - if: always() + - name: "KomaMRIFiles: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRIFiles - - name: "KomaMRIPlots dev setup" + - name: "KomaMRIPlots: Development Setup" + if: '!cancelled()' shell: bash run: | julia --color=yes --project="KomaMRIPlots" -e "using Pkg; Pkg.develop(PackageSpec(; path=\"./KomaMRIBase\"));" - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRIPlots: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRIPlots - - name: "Run tests for KomaMRIPlots" - if: always() + - name: "KomaMRIPlots: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRIPlots prefix: ${{ matrix.prefix }} # for `xvfb-run` - - name: "KomaMRI dev setup" + - name: "KomaMRI: Development Setup" + if: '!cancelled()' shell: julia --color=yes --project {0} run: | using Pkg @@ -95,9 +107,11 @@ jobs: PackageSpec(path=pwd(), subdir="KomaMRIFiles"), PackageSpec(path=pwd(), subdir="KomaMRIPlots") ]) - - uses: julia-actions/julia-buildpkg@v1 - - name: "Run tests for KomaMRI" - if: always() + - name: "KomaMRI: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRI: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: prefix: ${{ matrix.prefix }} # for `xvfb-run` diff --git a/.github/workflows/nightly.yml b/.github/workflows/nightly.yml index 398510d80..b6730546d 100644 --- a/.github/workflows/nightly.yml +++ b/.github/workflows/nightly.yml @@ -39,48 +39,64 @@ jobs: ${{ runner.os }}-test-${{ env.cache-name }}- ${{ runner.os }}-test- ${{ runner.os }}- - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRIBase: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRIBase - - name: "Run tests for KomaMRIBase" + - name: "KomaMRIBase: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRIBase - - name: "KomaMRICore dev setup" + - name: "KomaMRICore: Development Setup" + if: '!cancelled()' shell: bash run: | julia --color=yes --project="KomaMRICore" -e "using Pkg; Pkg.develop(PackageSpec(; path=\"./KomaMRIBase\"));" - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRICore: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRICore - - name: "Run tests for KomaMRICore" + - name: "KomaMRICore: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRICore - - name: "KomaMRIFiles dev setup" + - name: "KomaMRIFiles: Development Setup" + if: '!cancelled()' shell: bash run: | julia --color=yes --project="KomaMRIFiles" -e "using Pkg; Pkg.develop(PackageSpec(; path=\"./KomaMRIBase\"));" - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRIFiles: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRIFiles - - name: "Run tests for KomaMRIFiles" + - name: "KomaMRIFiles: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRIFiles - - name: "KomaMRIPlots dev setup" + - name: "KomaMRIPlots: Development Setup" + if: '!cancelled()' shell: bash run: | julia --color=yes --project="KomaMRIPlots" -e "using Pkg; Pkg.develop(PackageSpec(; path=\"./KomaMRIBase\"));" - - uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRIPlots: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 with: project: KomaMRIPlots - - name: "Run tests for KomaMRIPlots" + - name: "KomaMRIPlots: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: project: KomaMRIPlots prefix: ${{ matrix.prefix }} # for `xvfb-run` - - name: "KomaMRI dev setup" + - name: "KomaMRI: Development Setup" + if: '!cancelled()' shell: julia --color=yes --project {0} run: | using Pkg @@ -90,8 +106,11 @@ jobs: PackageSpec(path=pwd(), subdir="KomaMRIFiles"), PackageSpec(path=pwd(), subdir="KomaMRIPlots") ]) - - uses: julia-actions/julia-buildpkg@v1 - - name: "Run tests for KomaMRI" + - name: "KomaMRI: Build" + if: '!cancelled()' + uses: julia-actions/julia-buildpkg@v1 + - name: "KomaMRI: Run Tests" + if: '!cancelled()' uses: julia-actions/julia-runtest@v1 with: prefix: ${{ matrix.prefix }} # for `xvfb-run` diff --git a/KomaMRIBase/Project.toml b/KomaMRIBase/Project.toml index 9083e29a4..bafc4f95a 100644 --- a/KomaMRIBase/Project.toml +++ b/KomaMRIBase/Project.toml @@ -1,7 +1,7 @@ name = "KomaMRIBase" uuid = "d0bc0b20-b151-4d03-b2a4-6ca51751cb9c" authors = ["Carlos Castillo Passi "] -version = "0.8.2" +version = "0.8.3" [deps] Interpolations = "a98d9a8b-a2ab-59e6-89dd-64a1c18fca59" diff --git a/KomaMRIBase/src/KomaMRIBase.jl b/KomaMRIBase/src/KomaMRIBase.jl index 6573f50ae..49be52686 100644 --- a/KomaMRIBase/src/KomaMRIBase.jl +++ b/KomaMRIBase/src/KomaMRIBase.jl @@ -38,6 +38,8 @@ export Grad, RF, ADC, Delay export dur, get_block_start_times, get_samples export DiscreteSequence export discretize, get_adc_phase_compensation, get_adc_sampling_times +export is_Gx_on, is_Gy_on, is_Gz_on, is_RF_on, is_ADC_on +export time, ampl, freq # This are also used for simulation export kfoldperm, trapz, cumtrapz # Phantom diff --git a/KomaMRIBase/src/datatypes/Sequence.jl b/KomaMRIBase/src/datatypes/Sequence.jl index a3a893498..82e08a006 100644 --- a/KomaMRIBase/src/datatypes/Sequence.jl +++ b/KomaMRIBase/src/datatypes/Sequence.jl @@ -33,52 +33,48 @@ mutable struct Sequence DEF::Dict{String,Any} #Dictionary with information relevant to the reconstructor #Ext::Array{Extension,1} Sequence(GR, RF, ADC, DUR, DEF) = begin - @assert size(GR,2) .== size(RF,2) .== length(ADC) .== length(DUR) "The number of Gradient, RF, ADC, and DUR objects must be the same." - M,N = size(GR) - new([i <= M ? GR[i,j] : Grad(0, GR[1,j].T, GR[1,j].rise, GR[1,j].fall, GR[1,j].delay) for i=1:3, j=1:N], + @assert size(GR, 2) == size(RF,2) == length(ADC) == length(DUR) "The number of Gradient, RF, ADC, and DUR objects must be the same." + if size(GR, 1) < 3 + GR = vcat(GR, (0.0 .* GR[1:1, :] for i=1:3-size(GR, 1))...) + end + new(GR, RF, ADC, - maximum([GR.dur RF.dur ADC.dur DUR],dims=2)[:], + DUR, #maximum(Float64[GR.dur RF.dur ADC.dur DUR],dims=2)[:], DEF) end end # Main Constructors function Sequence(GR) - M, N = size(GR) - gr = [i <= M ? GR[i,j] : Grad(0, 0) for i in 1:3, j in 1:N] - rf = reshape([RF(0, 0) for i in 1:N], 1, :) - adc = [ADC(0, 0) for _ = 1:N] - return Sequence(gr, rf, adc, GR.dur, Dict()) + rf = reshape([RF(0.0, 0.0) for i in 1:size(GR, 2)], 1, :) + adc = [ADC(0, 0.0) for _ = 1:size(GR, 2)] + return Sequence(GR, rf, adc, GR.dur, Dict{String, Any}()) end function Sequence(GR, RF) - @assert size(GR, 2) .== size(RF, 2) "The number of Gradient, and RF objects must be the same." - M, N = size(GR) - gr = [i <= M ? GR[i,j] : Grad(0, 0) for i in 1:3, j in 1:N] - adc = [ADC(0, 0) for _ in 1:N] - dur = maximum([GR.dur RF.dur], dims=2)[:] - return Sequence(gr, RF, adc, dur, Dict()) + adc = [ADC(0, 0.0) for _ in 1:size(GR, 2)] + DUR = maximum([GR.dur RF.dur], dims=2)[:] + return Sequence(GR, RF, adc, DUR, Dict{String, Any}()) end function Sequence(GR, RF, ADC) - @assert size(GR, 2) .== size(RF, 2) .== length(ADC) "The number of Gradient, RF, and ADC objects must be the same." - M, N = size(GR) - gr = [i <= M ? GR[i,j] : Grad(0, 0) for i in 1:3, j in 1:N] - dur = maximum([GR.dur RF.dur ADC.dur], dims=2)[:] - return Sequence(gr, RF, ADC, dur, Dict()) + DUR = maximum([GR.dur RF.dur ADC.dur], dims=2)[:] + return Sequence(GR, RF, ADC, DUR, Dict{String, Any}()) end function Sequence(GR, RF, ADC, DUR) - @assert size(GR, 2) .== size(RF, 2) .== length(ADC) .== length(DUR) "The number of Gradient, RF, ADC, and DUR objects must be the same." - M, N = size(GR) - gr = [i <= M ? GR[i,j] : Grad(0, GR[1,j].T, GR[1,j].rise, GR[1,j].fall, GR[1,j].delay) for i in 1:3, j in 1:N] - dur = maximum([GR.dur RF.dur ADC.dur DUR], dims=2)[:] - return Sequence(gr, RF, ADC, dur, Dict()) + return Sequence(GR, RF, ADC, DUR, Dict{String, Any}()) end # Other constructors Sequence(GR::Array{Grad,1}) = Sequence(reshape(GR,1,:)) -Sequence(GR::Array{Grad,1}, RF::Array{RF,1})= Sequence(reshape(GR, :, 1), reshape(RF, 1, :), [ADC(0, 0) for i in 1:size(GR, 2)]) -Sequence(GR::Array{Grad,1}, RF::Array{RF,1}, A::ADC, DUR, DEF)= Sequence(reshape(GR, :, 1), reshape(RF, 1, :), [A], [DUR], DEF) -Sequence() = Sequence([Grad(0, 0)]) +Sequence(GR::Array{Grad,1}, RF::Array{RF,1})= Sequence(reshape(GR, :, 1), reshape(RF, 1, :), [ADC(0, 0.0) for i in 1:size(GR, 2)]) +Sequence(GR::Array{Grad,1}, RF::Array{RF,1}, A::ADC, DUR, DEF) = Sequence(reshape(GR, :, 1), reshape(RF, 1, :), [A], Float64[DUR], DEF) +Sequence() = Sequence( + Matrix{Grad}(undef, 3, 0), + Matrix{RF}(undef, 1, 0), + Vector{ADC}(undef, 0), + Vector{Float64}(undef, 0), + Dict{String, Any}() + ) """ str = show(io::IO, s::Sequence) @@ -93,12 +89,16 @@ Displays information about the Sequence struct `s` in the julia REPL. """ Base.show(io::IO, s::Sequence) = begin compact = get(io, :compact, false) - if !compact - nGRs = sum(is_Gx_on.(s)) + sum(is_Gy_on.(s)) + sum(is_Gz_on.(s)) - print(io, "Sequence[ τ = $(round(dur(s)*1e3;digits=3)) ms | blocks: $(length(s)) | ADC: $(sum(is_ADC_on.(s))) | GR: $nGRs | RF: $(sum(is_RF_on.(s))) | DEF: $(length(s.DEF)) ]") - else - print(io, "Sequence[τ = $(round(dur(s)*1e3;digits=3)) ms]") - end + if length(s) > 0 + if !compact + nGRs = sum(is_Gx_on.(s)) + sum(is_Gy_on.(s)) + sum(is_Gz_on.(s)) + print(io, "Sequence[ τ = $(round(dur(s)*1e3;digits=3)) ms | blocks: $(length(s)) | ADC: $(sum(is_ADC_on.(s))) | GR: $nGRs | RF: $(sum(is_RF_on.(s))) | DEF: $(length(s.DEF)) ]") + else + print(io, "Sequence[τ = $(round(dur(s)*1e3;digits=3)) ms]") + end + else + print(io, "Sequence[]") + end end #Sequence operations @@ -113,14 +113,14 @@ Base.lastindex(x::Sequence) = length(x.DUR) Base.copy(x::Sequence) where Sequence = Sequence([deepcopy(getfield(x, k)) for k ∈ fieldnames(Sequence)]...) #Arithmetic operations -recursive_merge(x::AbstractDict...) = merge(recursive_merge, x...) -recursive_merge(x::AbstractVector...) = cat(x...; dims=1) +recursive_merge(x::Dict{K, V}) where {K, V} = merge(recursive_merge, x...) +recursive_merge(x::Vector) = cat(x...; dims=1) recursive_merge(x...) = x[end] -+(x::Sequence, y::Sequence) = Sequence([x.GR y.GR], [x.RF y.RF], [x.ADC; y.ADC], [x.DUR; y.DUR], recursive_merge(x.DEF, y.DEF)) --(x::Sequence, y::Sequence) = Sequence([x.GR -y.GR], [x.RF y.RF], [x.ADC; y.ADC], [x.DUR; y.DUR], recursive_merge(x.DEF, y.DEF)) ++(x::Sequence, y::Sequence) = Sequence(hcat(x.GR, y.GR), hcat(x.RF, y.RF), vcat(x.ADC, y.ADC), vcat(x.DUR, y.DUR), merge(x.DEF, y.DEF)) +-(x::Sequence, y::Sequence) = Sequence(hcat(x.GR, -y.GR), hcat(x.RF, y.RF), vcat(x.ADC, y.ADC), vcat(x.DUR, y.DUR), merge(x.DEF, y.DEF)) -(x::Sequence) = Sequence(-x.GR, x.RF, x.ADC, x.DUR, x.DEF) -*(x::Sequence, α::Real) = Sequence(α*x.GR, x.RF, x.ADC, x.DUR, x.DEF) -*(α::Real, x::Sequence) = Sequence(α*x.GR, x.RF, x.ADC, x.DUR, x.DEF) +*(x::Sequence, α::Real) = Sequence(α .* x.GR, x.RF, x.ADC, x.DUR, x.DEF) +*(α::Real, x::Sequence) = Sequence(α .* x.GR, x.RF, x.ADC, x.DUR, x.DEF) *(x::Sequence, α::ComplexF64) = Sequence(x.GR, α.*x.RF, x.ADC, x.DUR, x.DEF) *(α::ComplexF64, x::Sequence) = Sequence(x.GR, α.*x.RF, x.ADC, x.DUR, x.DEF) *(x::Sequence, A::Matrix{Float64}) = Sequence(A*x.GR, x.RF, x.ADC, x.DUR, x.DEF) #TODO: change this, Rotation fo waveforms is broken @@ -130,11 +130,11 @@ recursive_merge(x...) = x[end] +(s::Sequence, g::Grad) = s + Sequence(reshape([g],1,1)) #Changed [a;;] for reshape(a,1,1) for Julia 1.6 +(g::Grad, s::Sequence) = Sequence(reshape([g],1,1)) + s #Changed [a;;] for reshape(a,1,1) for Julia 1.6 #RF operations -+(s::Sequence, r::RF) = s + Sequence(reshape([Grad(0,0)],1,1),reshape([r],1,1)) #Changed [a;;] for reshape(a,1,1) for Julia 1.6 -+(r::RF, s::Sequence) = Sequence(reshape([Grad(0,0)],1,1),reshape([r],1,1)) + s #Changed [a;;] for reshape(a,1,1) for Julia 1.6 ++(s::Sequence, r::RF) = s + Sequence(reshape([Grad(0.0,0.0)],1,1),reshape([r],1,1)) #Changed [a;;] for reshape(a,1,1) for Julia 1.6 ++(r::RF, s::Sequence) = Sequence(reshape([Grad(0.0,0.0)],1,1),reshape([r],1,1)) + s #Changed [a;;] for reshape(a,1,1) for Julia 1.6 #ADC operations -+(s::Sequence, a::ADC) = s + Sequence(reshape([Grad(0,0)],1,1),reshape([RF(0,0)],1,1),[a]) #Changed [a;;] for reshape(a,1,1) for Julia 1.6 -+(a::ADC, s::Sequence) = Sequence(reshape([Grad(0,0)],1,1),reshape([RF(0,0)],1,1),[a]) + s #Changed [a;;] for reshape(a,1,1) for Julia 1.6 ++(s::Sequence, a::ADC) = s + Sequence(reshape([Grad(0.0,0.0)],1,1),reshape([RF(0.0,0.0)],1,1),[a]) #Changed [a;;] for reshape(a,1,1) for Julia 1.6 ++(a::ADC, s::Sequence) = Sequence(reshape([Grad(0.0,0.0)],1,1),reshape([RF(0.0,0.0)],1,1),[a]) + s #Changed [a;;] for reshape(a,1,1) for Julia 1.6 #Sequence object functions size(x::Sequence) = size(x.GR[1,:]) @@ -151,7 +151,7 @@ Tells if the sequence `seq` has elements with ADC active, or active during time # Returns - `y`: (`::Bool`) boolean that tells whether or not the ADC in the sequence is active """ -is_ADC_on(x::Sequence) = any(x.ADC.N .> 0) +is_ADC_on(x::Sequence) = any(x-> x > 0, x.ADC.N) is_ADC_on(x::Sequence, t::AbstractVecOrMat) = begin N = length(x) ΔT = durs(x) @@ -308,7 +308,7 @@ always zero, and the final time corresponds to the duration of the sequence. # Returns - `T0`: (`::Vector`, `[s]`) start times of the blocks in a sequence """ -get_block_start_times(seq::Sequence) = cumsum([0; seq.DUR], dims=1) +get_block_start_times(seq::Sequence) = cumsum([0.0; seq.DUR], dims=1) """ samples = get_samples(seq::Sequence; off_val=0, max_rf_samples=Inf) @@ -328,74 +328,50 @@ Returns the samples of the events in `seq`. Each event, represented by `e::NamedTuple`, includes time samples (`e.t`) and amplitude samples (`e.A`) """ -get_samples(seq::Sequence; off_val=0, max_rf_samples=Inf) = begin - N = length(seq) +function get_samples(seq::Sequence, range; events=[:rf, :gr, :adc], freq_in_phase=false) + rf_samples = (;) # Empty NamedTuples + gr_samples = (;) # Empty NamedTuples + adc_samples = (;) # Empty NamedTuples T0 = get_block_start_times(seq) - # GRADs - t_gx = reduce(vcat, [get_theo_t(seq.GR[1,i]) .+ T0[i] for i in 1:N]) - t_gy = reduce(vcat, [get_theo_t(seq.GR[2,i]) .+ T0[i] for i in 1:N]) - t_gz = reduce(vcat, [get_theo_t(seq.GR[3,i]) .+ T0[i] for i in 1:N]) - A_gx = reduce(vcat, [get_theo_A(seq.GR[1,i]; off_val) for i in 1:N]) - A_gy = reduce(vcat, [get_theo_A(seq.GR[2,i]; off_val) for i in 1:N]) - A_gz = reduce(vcat, [get_theo_A(seq.GR[3,i]; off_val) for i in 1:N]) - # RFs - t_rf = reduce(vcat, [get_theo_t(seq.RF[1,i]; max_rf_samples) .+ T0[i] for i in 1:N]) - A_rf = reduce(vcat, [get_theo_A(rf; off_val, max_rf_samples) for rf in seq.RF]) - # ADCs - t_adc = reduce(vcat, [get_theo_t(seq.ADC[i]) .+ T0[i] for i in 1:N]) - A_adc = reduce(vcat, [get_theo_A(adc; off_val) for adc in seq.ADC]) - return ( - gx = (t = t_gx, A = A_gx), - gy = (t = t_gy, A = A_gy), - gz = (t = t_gz, A = A_gz), - rf = (t = t_rf, A = A_rf), - adc = (t = t_adc, A = A_adc) - ) -end - -""" - y = ⏢(A, t, ΔT, ζ1, ζ2, delay) - -Generates a trapezoidal waveform vector. - -# Arguments -- `A`: (`::Real`) amplitude -- `t`: (`::Vector{Float64}`, `[s]`) times to evaluate (actually it's a `1-row - ::Matrix{Float64}`) -- `ΔT`: (`::Real`, `[s]`) time duration of the top-flat -- `ζ1`: (`::Real`, `[s]`) rise time duration -- `ζ2`: (`::Real`, `[s]`) fall time duration -- `delay`: (`::Real`, `[s]`) delay time - -# Returns -- `y`: (`::Vector{Float64}`) trapezoidal waveform (actually it's a `1-row - ::Matrix{Float64}`) -""" -⏢(A, t, ΔT, ζ1, ζ2, delay) = begin - if sum(abs.(A)) != 0 && ΔT+ζ1+ζ2 != 0 # If no event just ignore calculations - #Getting amplitudes, only supports uniformly sampled waveforms for now - if length(A) != 1 - grad_raster = ΔT / length(A) - idx = ceil.(Int, (t .- delay .- ζ1) ./ grad_raster ) #Time to integer index - valid = 1 .<= idx .<= length(A) - idx[(!).(valid)] .= 1 - B = A[idx] .* valid - else - B = A - end - #Trapezoidal waveform - aux = (ζ1 .< t .- delay .< ζ1+ΔT) .* B - if ζ1 != 0 - aux .+= (0 .< t .- delay .<= ζ1) .* A[1] .* (t .- delay)./ζ1 - end - if ζ2 !=0 - aux .+= (ζ1+ΔT .<= t .- delay .< ζ1+ΔT+ζ2) .* A[end] .* (1 .- (t.-delay.-ζ1.-ΔT)./ζ2) - end - else - aux = zeros(size(t)) - end - aux + fill_if_empty(x) = isempty(x.t) && length(range) == length(seq) ? merge(x, (t=[0.0; dur(seq)], A=zeros(eltype(x.A), 2))) : x + # RF + if :rf in events + t_rf = reduce(vcat, T0[i] .+ time(seq.RF[1,i], :A) for i in range) + t_Δf = reduce(vcat, T0[i] .+ time(seq.RF[1,i], :Δf) for i in range) + A_rf = reduce(vcat, ampl(seq.RF[1,i]; freq_in_phase) for i in range) + A_Δf = reduce(vcat, freq(seq.RF[1,i]) for i in range) + rf_samples = ( + rf = fill_if_empty((t = t_rf, A = A_rf)), + Δf = fill_if_empty((t = t_Δf, A = A_Δf)) + ) + end + # Gradients + if :gr in events + t_gx = reduce(vcat, T0[i] .+ time(seq.GR[1,i]) for i in range) + t_gy = reduce(vcat, T0[i] .+ time(seq.GR[2,i]) for i in range) + t_gz = reduce(vcat, T0[i] .+ time(seq.GR[3,i]) for i in range) + A_gx = reduce(vcat, ampl(seq.GR[1,i]) for i in range) + A_gy = reduce(vcat, ampl(seq.GR[2,i]) for i in range) + A_gz = reduce(vcat, ampl(seq.GR[3,i]) for i in range) + gr_samples = ( + gx = fill_if_empty((t = t_gx, A = A_gx)), + gy = fill_if_empty((t = t_gy, A = A_gy)), + gz = fill_if_empty((t = t_gz, A = A_gz)) + ) + end + # ADC + if :adc in events + t_aq = reduce(vcat, T0[i] .+ time(seq.ADC[i]) for i in range) + A_aq = reduce(vcat, ampl(seq.ADC[i]) for i in range) + adc_samples = ( + adc = fill_if_empty((t = t_aq, A = A_aq)), + ) + end + # Merging events + event_samples = merge(rf_samples, gr_samples, adc_samples) + return event_samples end +get_samples(seq::Sequence; kwargs...) = get_samples(seq, 1:length(seq); kwargs...) """ Gx, Gy, Gz = get_grads(seq, t::Vector) @@ -415,41 +391,13 @@ Get the gradient array from sequence `seq` evaluated in time points `t`. - `Gz`: (`Vector{Float64}` or `1-row ::Matrix{Float64}`, `[T]`) gradient vector values in the z direction """ -function get_grads(seq, t::Vector) - gx = get_theo_Gi(seq, 1) - gy = get_theo_Gi(seq, 2) - gz = get_theo_Gi(seq, 3) - Gx = linear_interpolation(gx..., extrapolation_bc=0)(t) - Gy = linear_interpolation(gy..., extrapolation_bc=0)(t) - Gz = linear_interpolation(gz..., extrapolation_bc=0)(t) - (Gx, Gy, Gz) -end -function get_grads(seq, t::Matrix) - t_vec = t[:] - gx = get_theo_Gi(seq, 1) - gy = get_theo_Gi(seq, 2) - gz = get_theo_Gi(seq, 3) - Gx = linear_interpolation(gx..., extrapolation_bc=0)(t_vec) - Gy = linear_interpolation(gy..., extrapolation_bc=0)(t_vec) - Gz = linear_interpolation(gz..., extrapolation_bc=0)(t_vec) - (Gx', Gy', Gz') +function get_grads(seq, t::Union{Vector, Matrix}) + grad_samples = get_samples(seq; events=[:gr]) + for event in grad_samples + Interpolations.deduplicate_knots!(event.t; move_knots=true) + end + return Tuple(linear_interpolation(event..., extrapolation_bc=0.0).(t) for event in grad_samples) end -# hold_interpolation(range::AbstractVector, vs::AbstractVector; extrapolation_bc = Throw()) = -# extrapolate(interpolate((range, ), vs, Gridded(Constant{Previous}())), 0) -# get_grads(seq::Sequence,t) = begin -# #Amplitude -# A = seq.GR.A -# #Grad Timings -# T = seq.GR.T -# ζ1 = seq.GR.rise -# ζ2 = seq.GR.fall -# delay = seq.GR.delay -# #Sequence timings -# ΔT = durs(seq) #Duration of sequence block -# T0 = cumsum([0; ΔT[:]]) #Start time of each block -# #Waveforms -# (sum([⏢(A[j,i],t.-T0[i],T[j,i],ζ1[j,i],ζ2[j,i],delay[j,i]) for i=1:length(seq)]) for j=1:3) -# end """ B1, Δf_rf = get_rfs(seq::Sequence, t) @@ -464,18 +412,12 @@ Returns the RF pulses and the delta frequency. - `B1`: (`1-row ::Matrix{ComplexF64}`, `[T]`) vector of RF pulses - `Δf_rf`: (`1-row ::Matrix{Float64}`, `[Hz]`) delta frequency vector """ -get_rfs(seq::Sequence, t) = begin - ϵ = MIN_RISE_TIME - # Amplitude - A = seq.RF.A - Δf = seq.RF.Δf - # Timings - T = seq.RF.T - delay = seq.RF.delay - T0 = get_block_start_times(seq) - (sum([⏢(A[1,i], t .- T0[i], sum(T[i]) .- 2ϵ, ϵ, ϵ, delay[i]) for i=1:length(seq)]), - sum([⏢(Δf[1,i], t .- T0[i], sum(T[i]) .- 2ϵ, ϵ, ϵ, delay[i]) for i=1:length(seq)]) - ) +function get_rfs(seq, t::Union{Vector, Matrix}) + rf_samples = get_samples(seq; events=[:rf]) + for event in rf_samples + Interpolations.deduplicate_knots!(event.t; move_knots=true) + end + return Tuple(linear_interpolation(event..., extrapolation_bc=0.0).(t) for event in rf_samples) end """ diff --git a/KomaMRIBase/src/datatypes/sequence/ADC.jl b/KomaMRIBase/src/datatypes/sequence/ADC.jl index 3719fc374..9e09aa7c8 100644 --- a/KomaMRIBase/src/datatypes/sequence/ADC.jl +++ b/KomaMRIBase/src/datatypes/sequence/ADC.jl @@ -86,14 +86,7 @@ function get_adc_sampling_times(seq) times = Float64[] for i = 1:length(seq) if is_ADC_on(seq[i]) - δ = seq.ADC[i].delay - T = seq.ADC[i].T - N = seq.ADC[i].N - if N != 1 - t = range(0, T; length=N).+T0[i].+δ #range(0,T,N) works in Julia 1.7 - else - t = [T/2].+T0[i].+δ #range(0,T,N) works in Julia 1.7 - end + t = time(seq.ADC[i]) .+ T0[i] append!(times, t) end end @@ -127,3 +120,5 @@ function get_adc_phase_compensation(seq) end return phase end + +dur(adc::ADC) = adc.delay + adc.T diff --git a/KomaMRIBase/src/datatypes/sequence/Delay.jl b/KomaMRIBase/src/datatypes/sequence/Delay.jl index 03bcd778a..2ad619624 100644 --- a/KomaMRIBase/src/datatypes/sequence/Delay.jl +++ b/KomaMRIBase/src/datatypes/sequence/Delay.jl @@ -54,5 +54,10 @@ sequence. # Returns - `seq`: (`::Sequence`) delayed sequence """ -+(s::Sequence, d::Delay) = s + Sequence([Grad(0.,d.T)]) -+(d::Delay, s::Sequence) = Sequence([Grad(0.,d.T)]) + s ++(s::Sequence, d::Delay) = s + empty_seq(d.T) ++(d::Delay, s::Sequence) = empty_seq(d.T) + s +function empty_seq(T) + seq = Sequence([Grad(0., 0.);;]) + seq.DUR[1] = T + return seq +end diff --git a/KomaMRIBase/src/datatypes/sequence/Grad.jl b/KomaMRIBase/src/datatypes/sequence/Grad.jl index df9d73eba..600ef2c83 100644 --- a/KomaMRIBase/src/datatypes/sequence/Grad.jl +++ b/KomaMRIBase/src/datatypes/sequence/Grad.jl @@ -48,6 +48,7 @@ rotz(θ::Real) = [cos(θ) -sin(θ) 0; gr = Grad(A, T, rise) gr = Grad(A, T, rise, delay) gr = Grad(A, T, rise, fall, delay) + gr = Grad(A, T, rise, fall, delay, first, last) The Grad struct represents a gradient of a sequence event. @@ -74,20 +75,23 @@ mutable struct Grad rise::Real fall::Real delay::Real + first + last function Grad(A, T, rise, fall, delay) - all(T .< 0) || rise < 0 || fall < 0 || delay < 0 ? error("Gradient timings must be positive.") : new(A, T, rise, fall, delay) + all(T .< 0) || rise < 0 || fall < 0 || delay < 0 ? error("Gradient timings must be positive.") : new(A, T, rise, fall, delay, 0.0, 0.0) end function Grad(A, T, rise, delay) - all(T .< 0) < 0 || rise < 0 || delay < 0 ? error("Gradient timings must be positive.") : new(A, T, rise, rise, delay) + all(T .< 0) < 0 || rise < 0 || delay < 0 ? error("Gradient timings must be positive.") : new(A, T, rise, rise, delay, 0.0, 0.0) end function Grad(A, T, rise) - all(T .< 0) < 0 || rise < 0 ? error("Gradient timings must be positive.") : new(A, T, rise, rise, 0) + all(T .< 0) < 0 || rise < 0 ? error("Gradient timings must be positive.") : new(A, T, rise, rise, 0.0, 0.0, 0.0) end function Grad(A, T) - all(T .< 0) < 0 ? error("Gradient timings must be positive.") : new(A, T, 0, 0, 0) + all(T .< 0) < 0 ? error("Gradient timings must be positive.") : new(A, T, 0.0, 0.0, 0.0, 0.0, 0.0) end end + """ gr = Grad(f::Function, T::Real, N::Integer; delay::Real) @@ -113,9 +117,9 @@ julia> seq = Sequence([gx]); plot_seq(seq) ``` """ Grad(f::Function, T::Real, N::Integer=300; delay::Real=0) = begin - t = range(0, T; length=N) + t = range(0.0, T; length=N) G = f.(t) - return Grad(G, T, 0, 0, delay) + return Grad(G, T, 0.0, 0.0, delay) end @@ -142,7 +146,7 @@ Base.show(io::IO, x::Grad) = begin end else wave = length(x.A) == 1 ? "⊓" : "∿" - print(io, (sum(abs.(x.A)) > 0 ? wave : "⇿")*"($(r((x.delay+x.rise+x.fall+sum(x.T))*1e3)) ms)") + print(io, (is_on(x) ? wave : "⇿")*"($(r((x.delay+x.rise+x.fall+sum(x.T))*1e3)) ms)") end end @@ -171,12 +175,8 @@ getproperty(x::Matrix{Grad}, f::Symbol) = begin x[2,:] elseif f == :z && size(x,1) >= 3 x[3,:] - elseif f == :T || f == :rise || f == :fall || f == :delay - getproperty.(x,f) elseif f == :dur - T, ζ1, ζ2, delay = x.T, x.rise, x.fall, x.delay - ΔT = [sum(t) for t=T] .+ ζ1 .+ ζ2 .+ delay - maximum(ΔT,dims=1)[:] + maximum(dur.(x), dims=1)[:] else getproperty.(x,f) end @@ -195,7 +195,7 @@ end N, M = size(GR) [sum(A[i,1:N] .* GR[:,j]) for i=1:N, j=1:M] end -Base.zero(::Grad) = Grad(0,0) +Base.zero(::Grad) = Grad(0.0,0.0) size(g::Grad, i::Int64) = 1 #To fix [g;g;;] concatenation of Julia 1.7.3 /(x::Grad,α::Real) = Grad(x.A/α,x.T,x.rise,x.fall,x.delay) +(x::Grad,y::Grad) = Grad(x.A.+y.A,x.T,x.rise,x.fall,x.delay) diff --git a/KomaMRIBase/src/datatypes/sequence/RF.jl b/KomaMRIBase/src/datatypes/sequence/RF.jl index 185e7decc..1080a56e5 100644 --- a/KomaMRIBase/src/datatypes/sequence/RF.jl +++ b/KomaMRIBase/src/datatypes/sequence/RF.jl @@ -158,9 +158,9 @@ Calculates the flip angle α [deg] of an RF struct. α = γ ∫ B1(τ) dτ - `α`: (`::Int64`, `[deg]`) flip angle RF struct `x` """ get_flip_angle(x::RF) = begin - A, NA, T, NT = x.A, length(x.A), x.T, length(x.T) - dT = T / NA * NT - α = round(360 * γ * abs(sum(A .* dT)), digits=3) #Pulseq + dt = diff(time(x, :A)) + B1 = ampl(x) + α = round(360.0 * γ * abs(trapz(dt, B1)); digits=3) return α end diff --git a/KomaMRIBase/src/timing/KeyValuesCalculation.jl b/KomaMRIBase/src/timing/KeyValuesCalculation.jl index ae1721c74..abf55bbef 100644 --- a/KomaMRIBase/src/timing/KeyValuesCalculation.jl +++ b/KomaMRIBase/src/timing/KeyValuesCalculation.jl @@ -1,175 +1,128 @@ """ - A = get_theo_A(g::Grad; off_val=0) - A = get_theo_A(r::RF; off_val=0, max_rf_samples=Inf) - A = get_theo_A(d::ADC; off_val=0) + A = ampl(g::Grad) + A = ampl(r::RF) + A = ampl(d::ADC) -Get the theoretical amplitudes of a rectangle waveform for Grad, RF or ADC structs. This are -5 points: delay, start, rise, stop and fall. - -!!! note - In some cases the array result can have duplicated points, so it is necessary to remove - them whenever necessary. +Get the theoretical amplitudes for Grad, RF or ADC structs. # Arguments -- `g`: (`::Grad`) Gradient struct -- `r`: (`::RF`) RF struct -- `d`: (`::ADC`) ADC truct - -# Keywords -- `off_val`: (`::Float64`, `=0`) offset value for amplitude. In general, it is used for - not showing some points in plots by giving an `Inf` value -- `max_rf_samples`: (`::Float64`, `=Inf`) number of maximum samples for the RF struct. - In general, this parameter is not necessary to set +- `gr`: (`::Grad`) Gradient struct +- `rf`: (`::RF`) RF struct +- `adc`: (`::ADC`) ADC truct # Returns -- `A`: (`::Vector{Float64}`) vector with the amplitude key points of the rectangle - waveform +- `A`: (`::Vector{Number}`) vector with the amplitude theoretical points """ -get_theo_A(g::Grad; off_val=0) = begin - A = g.A - if length(A) == 1 - aux = [off_val; 0; A; A; 0] - else - aux = [off_val; 0; A; 0] - end - if sum(abs.(g.A)) == 0 - aux *= off_val +function ampl(gr::Grad) + if !is_on(gr) + return Float64[] + end + if !(gr.A isa Vector) && !(gr.T isa Vector) # trapezoidal + return [gr.first; gr.A; gr.A; gr.last] end - aux + return [gr.first; gr.A; gr.last] # uniformly-sampled and time-shaped end - -get_theo_A(r::RF; off_val=0, max_rf_samples=Inf) = begin - A = transpose([r.A r.A]); A = A[:] - if sum(abs.(r.A)) == 0 - aux = off_val * [1; 1; ones(length(A)); 1] +function ampl(rf::RF; freq_in_phase=false) + if !is_on(rf) + return ComplexF64[] + end + if !(rf.A isa Vector) + A = ComplexF64[0.0; rf.A; rf.A; 0.0] else - #Calculating frequency waveform - NA = length(r.A) - NT = length(r.T) - if NA > 1 && NT == 1 - dt = repeat([r.T/NA], outer=NA) - elseif NA > 1 && NT > 1 - dt = r.T[:] - elseif NA == 1 && NT == 1 - dt = r.T - end - freq = exp.(1im*2π*cumsum(r.Δf.*dt)) # exp(i ∫ᵗw(t)dt) - added_phase = transpose([freq freq])[:] - A = A .* added_phase - A[abs.(A).<=1e-10] .= 0 #Remove small values - #Output - aux = [off_val; 0; A; 0] - end - #Subsample - if length(aux) > max_rf_samples - n = floor(Int, length(aux) / max_rf_samples) - aux = aux[[1; 2:n:end-1; end]] - end - aux + A = ComplexF64[0.0; rf.A; 0.0] # uniformly-sampled and time-shaped + end + if freq_in_phase + t0 = time(rf, :Δf) + t = time(rf) + Interpolations.deduplicate_knots!(t0; move_knots=true) + Interpolations.deduplicate_knots!(t; move_knots=true) + f = linear_interpolation(t0, freq(rf)).(t) + A = A .* exp.(im*2π*[0; cumtrapz(diff(t), f)]) + end + return A end - -get_theo_A(d::ADC; off_val=0) = begin - N = [1 1]'; N = N[:] - if d.N == 0 - aux = off_val * [1; 1; ones(length(N)); 1] +function freq(rf::RF) + if !is_on(rf) + return Float64[] + end + if !(rf.Δf isa Vector) + df = [0.0; rf.Δf; rf.Δf; 0.0] else - aux = [off_val; 0; N; 0] - end - aux + df = [0.0; rf.Δf; 0.0] # uniformly-sampled and time-shaped + end + return df +end +function ampl(adc::ADC) + if !is_on(adc) + return Bool[] + end + return ones(Bool, adc.N) end """ - t = get_theo_t(g::Grad) - t = get_theo_t(r::RF; max_rf_samples=Inf) - t = get_theo_t(d::ADC) - -Get the theoretical times of a rectangle waveform for Grad, RF or ADC structs. This are -5 points: delay, start, rise, stop and fall. + t = time(gr::Grad) + t = time(rf::RF) + t = time(adc::ADC) -!!! note - In some cases the array result can have duplicated points, so it is necessary to remove - them whenever necessary. +Get the theoretical times for Grad, RF or ADC structs. # Arguments -- `g`: (`::Grad`) Gradient struct -- `r`: (`::RF`) RF struct -- `d`: (`::ADC`) ADC truct - -# Keywords -- `max_rf_samples`: (`::Float64`, `=Inf`) number of maximum samples for the RF struct. - In general, this parameter is not necessary to set +- `gr`: (`::Grad`) Gradient struct +- `rf`: (`::RF`) RF struct +- `adc`: (`::ADC`) ADC truct # Returns -- `t`: (`::Vector{Float64}`) vector with the time key points of the rectangle waveform +- `t`: (`::Vector{Number}`) vector with the time theoretical points """ -get_theo_t(g::Grad) = begin - NT, T, NA = length(g.T), g.T, length(g.A) - if sum(T) != 0 - if NA == 1 && NT == 1 - trf = [0; T] - elseif NA>1 && NT == 1 - trf = cumsum([0; T/(NA-1).*ones(NA-1)]) - elseif NA>1 && NT>1 - trf = cumsum([0; T.*ones(NT)]) - end - t = g.delay .+ g.rise .+ trf - else - t = [g.delay+g.rise; g.delay+g.rise] - end - aux = [0; g.delay; t; g.delay+g.rise+sum(g.T)+g.fall] - aux +function time(gr::Grad) + if !is_on(gr) + return Float64[] + end + if !(gr.A isa Vector) && !(gr.T isa Vector) + t = cumsum([gr.delay; gr.rise; gr.T; gr.fall]) # trapezoidal + elseif gr.A isa Vector && gr.T isa Vector + NT = length(gr.T) + t = cumsum([gr.delay; gr.rise; gr.T.*ones(NT); gr.fall]) # time-shaped + else + NA = length(gr.A) + t = cumsum([gr.delay; gr.rise; gr.T/(NA-1).*ones(NA-1); gr.fall]) # uniformly-sampled + end + t[end-1] -= MIN_RISE_TIME #Fixes incorrect block interpretation + return t end - -get_theo_t(r::RF; max_rf_samples=Inf) = begin - if sum(r.T) != 0 - NA, T, NT = length(r.A), r.T, length(r.T) - dT = T / NA * NT - trf = cumsum([0; dT.*ones(NA)]) - t = r.delay .+ trf - else - t = [r.delay; r.delay] - end - t = [t t]'; t = t[:] - t = [0; t] - #Subsample - if length(t) > max_rf_samples - n = floor(Int, length(t) / max_rf_samples) - t = t[[1; 2:n:end-1; end]] - end - t +function time(rf::RF, key::Symbol) + if !is_on(rf) + return Float64[] + end + rfA = getproperty(rf, key) + if !(rfA isa Vector) && !(rf.T isa Vector) + t = cumsum([rf.delay; 0.0; rf.T; 0.0]) # pulse + elseif rfA isa Vector && rf.T isa Vector + NT = length(rf.T) + t = cumsum([rf.delay; 0.0; rf.T.*ones(NT); 0.0]) # time-shaped + elseif !(rfA isa Vector) + t = cumsum([rf.delay; 0.0; sum(rf.T); 0.0]) # df constant + else + NA = length(rf.A) + t = cumsum([rf.delay; 0.0; rf.T/(NA-1).*ones(NA-1); 0.0]) # uniformly-sampled + end + t[end-1] -= MIN_RISE_TIME #Fixes incorrect block interpretation + return t end - -get_theo_t(d::ADC) = begin - t = [d.delay; d.delay+d.T] - t = [t t]'; t = t[1:end-1] - [0; t; d.delay+d.T] +time(rf::RF) = time(rf, :A) +function time(adc::ADC) + if !is_on(adc) + return range(0.0,0.0,0) #empty + end + if adc.N != 1 + t = range(0.0, adc.T; length=adc.N) .+ adc.delay + else + t = range(adc.T/2, adc.T/2, 1) .+ adc.delay + end + return t end - -""" - t, g = get_theo_Gi(seq, idx) - -Get the theoretical gradient for a sequence in a defined axis. - -# Arguments -- `seq`: (`::Sequence`) Sequence struct -- `idx`: (`::Int64`, opts=[1, 2, 3]) axis x, y or z for the gradient - -# Returns -- `t`: (`::Vector{Float64}`) time key points -- `g`: (`::Vector{Float64}`) amplitude key points -""" -get_theo_Gi(seq, idx) = begin - N = length(seq) - T0 = get_block_start_times(seq) - t = vcat([get_theo_t(seq.GR[idx,i]) .+ T0[i] for i=1:N]...) - G = vcat([get_theo_A(seq.GR[idx,i]) for i=1:N]...) #; off_val=0 <---potential solution - #Removing duplicated points - #TODO: do this properly. As it is now it generates a bug for slew rates that are too high - # mask = (G .== 0) #<---potential solution - # t = t[mask] - # G = G[mask] - Interpolations.deduplicate_knots!(t; move_knots=true) - return (t, G) -end +is_on(x::Grad) = any(x->abs.(x) > .0, x.A) +is_on(x::RF) = any(x->abs.(x) > .0, x.A) +is_on(x::ADC) = x.N > 0 diff --git a/KomaMRIBase/src/timing/TimeStepCalculation.jl b/KomaMRIBase/src/timing/TimeStepCalculation.jl index 32b4c2afa..cc59dca8c 100644 --- a/KomaMRIBase/src/timing/TimeStepCalculation.jl +++ b/KomaMRIBase/src/timing/TimeStepCalculation.jl @@ -1,9 +1,9 @@ -const MIN_RISE_TIME = 1e-10 +const MIN_RISE_TIME = 1e-14 """ array_of_ranges = kfoldperm(N, k; breaks=[]) -Divides a list of indices from 1 to `N` into `k` groups. +Divides a list of indices from 1 to `N` into `k` groups. # Arguments - `N`: (`::Integer`) number of elements to be ordered @@ -100,7 +100,7 @@ function get_variable_times(seq; Δt=1e-3, Δt_rf=1e-5) t1 = t0 + delay t2 = t1 + sum(T) rf0 = t0 + get_RF_center(y) #get_RF_center includes delays - taux = points_from_key_times([t1,t1+ϵ,rf0,t2-ϵ,t2]; dt=Δt_rf) # Arbitrary RF. Points (t1+ϵ, t2-ϵ) added to fix bug with ADCs + taux = points_from_key_times([t1, t1 + ϵ, rf0, t2 - ϵ, t2]; dt=Δt_rf) append!(t, taux) end if is_GR_on(s) @@ -109,8 +109,8 @@ function get_variable_times(seq; Δt=1e-3, Δt_rf=1e-5) if is_Gy_on(s) append!(active_gradients, s.GR.y) end if is_Gz_on(s) append!(active_gradients, s.GR.z) end for y = active_gradients - ts = get_theo_t(y) .+ t0 - taux = points_from_key_times([ts[1]+ϵ; ts; ts[end]-ϵ]; dt=Δt) #The ±ϵ fixes # + ts = time(y) .+ t0 + taux = points_from_key_times([ts[1] + ϵ; ts; ts[end] - ϵ]; dt=Δt) append!(t, taux) end end diff --git a/KomaMRIBase/src/timing/TrapezoidalIntegration.jl b/KomaMRIBase/src/timing/TrapezoidalIntegration.jl index 3e1b6601c..7bf918dd5 100644 --- a/KomaMRIBase/src/timing/TrapezoidalIntegration.jl +++ b/KomaMRIBase/src/timing/TrapezoidalIntegration.jl @@ -18,11 +18,16 @@ Trapezoidal integration for every spin of a phantom. - `y`: (`Ns x 1 ::Matrix{Float64}`, `[T*s]`) vector where every element is the integral of (Gx * x + Gy * y + Gz * z) * Δt for every spin of a phantom """ -function trapz(Δt::AbstractArray{T}, x::AbstractArray{T}) where {T<:Real} +function trapz(Δt::AbstractMatrix{T}, x::AbstractMatrix{TX}) where {T<:Real, TX<:Union{T, Complex{T}}} y = (x[:, 2:end] .+ x[:, 1:end-1]) .* (Δt / 2) y = sum(y, dims=2) return y end +function trapz(Δt::AbstractVector{T}, x::AbstractVector{TX}) where {T<:Real, TX<:Union{T, Complex{T}}} + y = (x[2:end] .+ x[1:end-1]) .* (Δt / 2) + y = sum(y) + return y +end """ y = cumtrapz(Δt, x) @@ -44,3 +49,8 @@ function cumtrapz(Δt::AbstractArray{T}, x::AbstractArray{T}) where {T<:Real} y = cumsum(y, dims=2) return y end +function cumtrapz(Δt::AbstractVector{T}, x::AbstractVector{T}) where {T<:Real} + y = (x[2:end] .+ x[1:end-1]) .* (Δt / 2) + y = cumsum(y) + return y +end diff --git a/KomaMRIBase/test/runtests.jl b/KomaMRIBase/test/runtests.jl index 8abfdfee7..38368f46a 100644 --- a/KomaMRIBase/test/runtests.jl +++ b/KomaMRIBase/test/runtests.jl @@ -6,7 +6,7 @@ using TestItems, TestItemRunner @testset "Init" begin sys = Scanner() B1 = sys.B1; durRF = π/2/(2π*γ*B1) #90-degree hard excitation pulse - EX = PulseDesigner.RF_hard(B1, durRF, sys; G=[0,0,0]) + EX = PulseDesigner.RF_hard(B1, durRF, sys; G=[0.0,0.0,0.0]) @test dur(EX) ≈ durRF #RF length matches what is supposed to be #ACQ construction @@ -15,7 +15,7 @@ using TestItems, TestItemRunner EPI = PulseDesigner.EPI(FOV, N, sys) TE = 30e-3 d1 = TE-dur(EPI)/2-dur(EX) - d1 = d1 > 0 ? d1 : 0 + d1 = d1 > 0 ? d1 : 0.0 if d1 > 0 DELAY = Delay(d1) end #Sequence construction @@ -76,11 +76,11 @@ using TestItems, TestItemRunner grad = Grad(A, T) A, T = rand(2) - g1, g2 = Grad(A,T), Grad(A,T,0,0,0) + g1, g2 = Grad(A,T), Grad(A,T,0.0,0.0,0.0) @test g1 ≈ g2 A, T, ζ = rand(3) - g1, g2 = Grad(A,T,ζ), Grad(A,T,ζ,ζ,0) + g1, g2 = Grad(A,T,ζ), Grad(A,T,ζ,ζ,0.0) @test g1 ≈ g2 A, T, delay, ζ = rand(4) @@ -91,7 +91,7 @@ using TestItems, TestItemRunner T, N = 1e-3, 100 f = t -> sin(π*t / T) gradw = Grad(f, T, N) - @test gradw.A ≈ f.(range(0, T; length=N)) + @test gradw.A ≈ f.(range(0.0, T; length=N)) # Test Grad operations α = 3 @@ -143,11 +143,11 @@ using TestItems, TestItemRunner #Sanity checks of constructors (A [T], T [s], Δf[Hz], delay [s]) A, T = rand(2) - r1, r2 = RF(A,T), RF(A,T,0,0) + r1, r2 = RF(A,T), RF(A,T,0.0,0.0) @test r1 ≈ r2 A, T, Δf = rand(3) - r1, r2 = RF(A,T,Δf), RF(A,T,Δf,0) + r1, r2 = RF(A,T,Δf), RF(A,T,Δf,0.0) @test r1 ≈ r2 # Just checking to ensure that show() doesn't get stuck and that it is covered @@ -187,7 +187,7 @@ using TestItems, TestItemRunner @test true # Test addition of a delay to a sequence - seq = Sequence() + seq = Sequence([Grad(0.0, 0.0)]) ds = delay + seq @test dur(ds[1]) ≈ delay.T && dur(ds[2]) ≈ .0 sd = seq + delay @@ -245,17 +245,27 @@ using TestItems, TestItemRunner @test seqd[i1].t ≈ [t[i1]] @test seqd[i1:i2-1].t ≈ t[i1:i2] - T, N = 1, 4 - seq = RF(1, 1) - seq += Sequence([Grad(1, 1)]) - seq += ADC(N, 1) + T, N = 1.0, 4 + seq = RF(1.0e-6, 1.0) + seq += Sequence([Grad(1.0e-3, 1.0)]) + seq += ADC(N, 1.0) sampling_params = KomaMRIBase.default_sampling_params() sampling_params["Δt"], sampling_params["Δt_rf"] = T/N, T/N - seqd = KomaMRIBase.discretize(seq; sampling_params) - i = Int(floor(length(seqd) / 3)) - @test is_RF_on(seq[1]) == is_RF_on(seqd[1*i:1*i+1]) && is_GR_on(seq[1]) == is_GR_on(seqd[1*i:1*i+1]) && is_ADC_on(seq[1]) == is_ADC_on(seqd[1*i:1*i+1]) - @test is_RF_on(seq[2]) == is_RF_on(seqd[2*i:2*i+1]) && is_GR_on(seq[2]) == is_GR_on(seqd[2*i:2*i+1]) && is_ADC_on(seq[2]) == is_ADC_on(seqd[2*i:2*i+1]) - @test is_RF_on(seq[3]) == is_RF_on(seqd[3*i:3*i+1]) && is_GR_on(seq[3]) == is_GR_on(seqd[3*i:3*i+1]) && is_ADC_on(seq[3]) == is_ADC_on(seqd[3*i:3*i+1]) + seqd1 = KomaMRIBase.discretize(seq[1]; sampling_params) + seqd2 = KomaMRIBase.discretize(seq[2]; sampling_params) + seqd3 = KomaMRIBase.discretize(seq[3]; sampling_params) + # Block 1 + @test is_RF_on(seq[1]) == is_RF_on(seqd1) + @test is_GR_on(seq[1]) == is_GR_on(seqd1) + @test is_ADC_on(seq[1]) == is_ADC_on(seqd1) + # Block 2 + @test is_RF_on(seq[2]) == is_RF_on(seqd2) + @test is_GR_on(seq[2]) == is_GR_on(seqd2) + @test is_ADC_on(seq[2]) == is_ADC_on(seqd2) + # Block 3 + @test is_RF_on(seq[3]) == is_RF_on(seqd3) + @test is_GR_on(seq[3]) == is_GR_on(seqd3) + @test is_ADC_on(seq[3]) == is_ADC_on(seqd3) @test KomaMRIBase.is_GR_off(seqd) == !KomaMRIBase.is_GR_on(seqd) @test KomaMRIBase.is_RF_off(seqd) == !KomaMRIBase.is_RF_on(seqd) @test KomaMRIBase.is_ADC_off(seqd) == !KomaMRIBase.is_ADC_on(seqd) @@ -321,10 +331,10 @@ end @testitem "PulseDesigner" tags=[:base] begin @testset "RF_sinc" begin sys = Scanner() - B1 = 23.4731e-6 # For 90 deg flip angle + B1 = 23.4e-6 # For 90 deg flip angle Trf = 1e-3 rf = PulseDesigner.RF_sinc(B1, Trf, sys; TBP=4) - @test KomaMRIBase.get_flip_angles(rf)[1] ≈ 90 + @test round(KomaMRIBase.get_flip_angles(rf)[1]) ≈ 90 end @testset "Spiral" begin sys = Scanner() diff --git a/KomaMRICore/test/runtests.jl b/KomaMRICore/test/runtests.jl index 3341140e5..cbd456429 100644 --- a/KomaMRICore/test/runtests.jl +++ b/KomaMRICore/test/runtests.jl @@ -293,10 +293,11 @@ end rf_phase = [0, π/2] seq = Sequence() seq += ADC(N, Tadc) - for i=1:2 - global seq += RF(B1 .* exp(1im*rf_phase[i]), Trf) - global seq += ADC(N, Tadc) - end + seq += RF(B1 .* exp(1im*rf_phase[1]), Trf) + seq += ADC(N, Tadc) + seq += RF(B1 .* exp(1im*rf_phase[2]), Trf) + seq += ADC(N, Tadc) + sim_params = Dict{String, Any}("Δt_rf"=>1e-5, "gpu"=>false) raw = @suppress simulate(obj, seq, sys; sim_params) @@ -339,10 +340,10 @@ end rf_phase = [0, π/2] seq = Sequence() seq += ADC(N, Tadc) - for i=1:2 - global seq += RF(B1 .* exp(1im*rf_phase[i]), Trf) - global seq += ADC(N, Tadc) - end + seq += RF(B1 .* exp(1im*rf_phase[1]), Trf) + seq += ADC(N, Tadc) + seq += RF(B1 .* exp(1im*rf_phase[2]), Trf) + seq += ADC(N, Tadc) sim_params = Dict{String, Any}("Δt_rf"=>1e-5, "gpu"=>true) raw = @suppress simulate(obj, seq, sys; sim_params) @@ -395,9 +396,6 @@ end raw1 = @suppress simulate(obj, seq1, sys; sim_params) raw2 = @suppress simulate(obj, seq2, sys; sim_params) - println(raw1.profiles[1].data) - println(raw2.profiles[1].data) - @test raw1.profiles[1].data ≈ raw2.profiles[1].data end @@ -413,7 +411,7 @@ end sig = @suppress simulate(obj, seq, sys; sim_params) sig = sig / prod(size(obj)) sim_params["sim_method"] = KomaMRICore.BlochDict() - sig2 = simulate(obj, seq, sys; sim_params) + sig2 = @suppress simulate(obj, seq, sys; sim_params) sig2 = sig2 / prod(size(obj)) @test sig ≈ sig2 @@ -439,7 +437,7 @@ end # Simulate the slice profile sim_params = Dict{String, Any}("Δt_rf" => Trf / length(seq.RF.A[1])) - M = simulate_slice_profile(seq; z, sim_params) + M = @suppress simulate_slice_profile(seq; z, sim_params) # For the time being, always pass the test @test true diff --git a/KomaMRIFiles/src/Sequence/Pulseq.jl b/KomaMRIFiles/src/Sequence/Pulseq.jl index 4063cc358..a620de84c 100644 --- a/KomaMRIFiles/src/Sequence/Pulseq.jl +++ b/KomaMRIFiles/src/Sequence/Pulseq.jl @@ -77,9 +77,9 @@ read_blocks Read the [BLOCKS] section of a sequence file. open MR sequence file and return the event table. """ function read_blocks(io, blockDurationRaster, version_combined) - eventTable = Dict() - blockDurations = Dict() - delayIDs_tmp = Dict() + eventTable = Dict{Int64, Vector{Int64}}() + blockDurations = Dict{Int64, Float64}() + delayIDs_tmp = Dict{Int64, Float64}() while true if version_combined <= 1002001 NumberBlockEvents = 7 @@ -87,14 +87,15 @@ function read_blocks(io, blockDurationRaster, version_combined) NumberBlockEvents = 8 end - fmt = Scanf.Format("%i "^NumberBlockEvents) - r, blockEvents... = scanf(readline(io), fmt, zeros(Int,NumberBlockEvents)...) + read_event = readline(io) + !isempty(read_event) || break + blockEvents = parse.(Int64, split(read_event)) if blockEvents[1] != 0 if version_combined <= 1002001 - eventTable[blockEvents[1]] = [0 blockEvents[3:end]... 0] + eventTable[blockEvents[1]] = Int64[0; blockEvents[3:end]...; 0] else - eventTable[blockEvents[1]] = [0 blockEvents[3:end]...] + eventTable[blockEvents[1]] = Int64[0; blockEvents[3:end]...] end if version_combined >= 1004000 @@ -104,7 +105,7 @@ function read_blocks(io, blockDurationRaster, version_combined) end end - r == NumberBlockEvents || break #Break on white space + length(blockEvents) == NumberBlockEvents || break #Break on white space end eventTable, blockDurations, delayIDs_tmp end @@ -154,8 +155,8 @@ function read_shapes(io, forceConvertUncompressed) _, num_samples = @scanf(readline(io), "num_samples %i", Int) shape = Float64[] while true #Reading shape data - r, data_point = @scanf(readline(io), "%f", Float64) - r == 1 || break #Break if no sample + data_point = tryparse(Float64, readline(io)) + !isnothing(data_point) || break #Break if no sample append!(shape, data_point) end # check if conversion is needed: in v1.4.x we use length(data)==num_samples @@ -245,7 +246,7 @@ function decompress_shape(num_samples, data; forceDecompression = false) countPack = 1 # counter 1: points to the current compressed sample countUnpack = 1 # counter 2: points to the current uncompressed sample - for i = 1:length(dataPackMarkers) + for i = eachindex(dataPackMarkers) nextPack = dataPackMarkers[i] # careful, this index may have "false positives" , e.g. if the value 3 repeats 3 times, then we will have 3 3 3 currUnpackSamples = nextPack - countPack if currUnpackSamples < 0 # this rejects false positives @@ -275,23 +276,45 @@ function decompress_shape(num_samples, data; forceDecompression = false) w end -#""" -#READ Load sequence from file. -# READ(seqObj, filename, ...) Read the given filename and load sequence -# data into sequence object. -# -# optional parwameter 'detectRFuse' can be given to let the function -# infer the currently missing flags concerning the intended use of the RF -# pulses (excitation, refocusing, etc). These are important for the -# k-space trajectory calculation -# -# Examples: -# Load the sequence defined in gre.seq in my_sequences directory -# -# read(seqObj,'my_sequences/gre.seq') -# -# See also write -#""" +""" + fix_first_last_grads!(seq::Sequence) + +Updates the Sequence `seq` with new first and last points for gradients. +""" +function fix_first_last_grads!(seq::Sequence) + # Add first and last Pulseq points + grad_prev_last = [0.0; 0.0; 0.0] + for bi in 1:length(seq) + for gi in 1:3 + gr = seq.GR[gi, bi] + if seq.DUR[bi] > 0 + if sum(abs.(gr.A)) == 0 # this is for no-gradient case + grad_prev_last[gi] = 0.0 + continue + else + if gr.A isa Vector # this is for the uniformly-shaped or time-shaped case + if gr.delay > 0 + grad_prev_last[gi] = 0.0 + end + seq.GR[gi, bi].first = grad_prev_last[gi] + if gr.T isa Array # this is for time-shaped case (I assume it is the extended trapezoid case) + seq.GR[gi, bi].last = gr.A[end] + else + odd_step1 = [seq.GR[gi, bi].first; 2 * gr.A] + odd_step2 = odd_step1 .* (mod.(1:length(odd_step1), 2) * 2 .- 1) + waveform_odd_rest = cumsum(odd_step2) .* (mod.(1:length(odd_step2), 2) * 2 .- 1) + seq.GR[gi, bi].last = waveform_odd_rest[end] + end + grad_prev_last[gi] = seq.GR[gi, bi].last + else # this is for the trapedoid case + grad_prev_last[gi] = 0.0 + end + end + end + end + end +end + """ seq = read_seq(filename) @@ -381,7 +404,7 @@ function read_seq(filename) if version_combined < 1004000 # scan through the RF objects for i = 0:length(rfLibrary)-1 - rfLibrary[i]["data"] = [rfLibrary[i]["data"][1:3]' 0 rfLibrary[i]["data"][4:end]'] + rfLibrary[i]["data"] = [rfLibrary[i]["data"][1:3]' 0.0 rfLibrary[i]["data"][4:end]'] end # scan through the gradient objects and update 't'-s (trapezoids) und 'g'-s (free-shape gradients) for i = 0:length(gradLibrary)-1 @@ -402,7 +425,7 @@ function read_seq(filename) end if gradLibrary[i]["type"] == 'g' #(1)amplitude (2)amp_shape_id (3)time_shape_id (4)delay - gradLibrary[i]["data"] = [gradLibrary[i]["data"][1:2]; 0; gradLibrary[i]["data"][3:end]] + gradLibrary[i]["data"] = [gradLibrary[i]["data"][1:2]; 0.0; gradLibrary[i]["data"][3:end]] end end # for versions prior to 1.4.0 blockDurations have not been initialized @@ -434,26 +457,20 @@ function read_seq(filename) for i = 1:length(blockEvents) seq += get_block(obj, i) end + # Add first and last points for gradients #320 + fix_first_last_grads!(seq) # Final details - # Remove dummy seq block at the start, Issue #203 - seq = seq[2:end] - # Hack for including extension and triggers + # Hack for including extension and triggers, this will be done properly for #308 and #323 seq.DEF["additional_text"] = read_Extension(extensionLibrary, triggerLibrary) #Temporary hack - seq.DEF = KomaMRIBase.recursive_merge(obj["definitions"], seq.DEF) + seq.DEF = merge(obj["definitions"], seq.DEF) # Koma specific details for reconstrucion seq.DEF["FileName"] = basename(filename) seq.DEF["PulseqVersion"] = version_combined seq.DEF["signature"] = signature - if !haskey(seq.DEF,"Nx") - Nx = maximum(seq.ADC.N) - RF_ex = (get_flip_angles(seq) .<= 90.01) .* is_RF_on.(seq) - Nz = max(length(unique(seq.RF[RF_ex].Δf)), 1) - Ny = sum(is_ADC_on.(seq)) / Nz |> x->floor(Int,x) - - seq.DEF["Nx"] = Nx #Number of samples per ADC - seq.DEF["Ny"] = Ny #Number of ADC events - seq.DEF["Nz"] = Nz #Number of unique RF frequencies, in a 3D acquisition this should not work - end + # Guessing recon dimensions + seq.DEF["Nx"] = get(seq.DEF, "Nx", maximum(adc.N for adc = seq.ADC)) + seq.DEF["Ny"] = get(seq.DEF, "Ny", sum(map(is_ADC_on, seq))) + seq.DEF["Nz"] = get(seq.DEF, "Ny", 1) #Koma sequence return seq end @@ -474,7 +491,7 @@ Reads the gradient. It is used internally by [`get_block`](@ref). - `grad`: (::Grad) Gradient struct """ function read_Grad(gradLibrary, shapeLibrary, Δt_gr, i) - G = Grad(0,0) + G = Grad(0.0,0.0) if isempty(gradLibrary) || i==0 return G end @@ -499,8 +516,8 @@ function read_Grad(gradLibrary, shapeLibrary, Δt_gr, i) G = Grad(gA, gT, Δt_gr/2, Δt_gr/2, delay) else gt = decompress_shape(shapeLibrary[time_shape_id]...) - gT = (gt[2:end] .- gt[1:end-1]) * Δt_gr - G = Grad(gA,gT,0,0,delay) + gT = diff(gt) * Δt_gr + G = Grad(gA,gT,0.0,0.0,delay) end end G @@ -521,6 +538,11 @@ Reads the RF. It is used internally by [`get_block`](@ref). - `rf`: (`1x1 ::Matrix{RF}`) RF struct """ function read_RF(rfLibrary, shapeLibrary, Δt_rf, i) + + if isempty(rfLibrary) || i==0 + return reshape([RF(0.0,0.0)], 1, 1) + end + #Unpacking #(1)amplitude (2)mag_id (3)phase_id (4)time_shape_id (5)delay (6)freq (7)phase r = rfLibrary[i]["data"] @@ -533,23 +555,20 @@ function read_RF(rfLibrary, shapeLibrary, Δt_rf, i) phase = r[7] #Amplitude and phase waveforms if amplitude != 0 && mag_id != 0 - rfA = decompress_shape(shapeLibrary[mag_id]...)[1:end-1] - rfϕ = decompress_shape(shapeLibrary[phase_id]...)[1:end-1] + rfA = decompress_shape(shapeLibrary[mag_id]...) + rfϕ = decompress_shape(shapeLibrary[phase_id]...) @assert all(rfϕ.>=0) "[RF id $i] Phase waveform rfϕ must have non-negative samples (1.>=rfϕ.>=0). " Nrf = shapeLibrary[mag_id][1] - 1 rfAϕ = amplitude .* rfA .* exp.(1im*(2π*rfϕ .+ phase)) else - rfA = 0 - rfϕ = 0 - Nrf = 0 - rfAϕ = 0 + rfAϕ = ComplexF64[0.0] end #Creating timings if time_shape_id == 0 #no time waveform rfT = Nrf * Δt_rf else rft = decompress_shape(shapeLibrary[time_shape_id]...) - rfT = (rft[2:end] .- rft[1:end-1]) * Δt_rf + rfT = diff(rft) * Δt_rf end R = reshape([RF(rfAϕ,rfT,freq,delay)],1,1)#[RF(rfAϕ,rfT,freq,delay);;] R @@ -568,13 +587,14 @@ Reads the ADC. It is used internally by [`get_block`](@ref). - `adc`: (`1x1 ::Vector{ADC}`) ADC struct """ function read_ADC(adcLibrary, i) + + if isempty(adcLibrary) || i==0 + return [ADC(0, 0)] + end + #Unpacking #(1)num (2)dwell (3)delay (4)freq (5)phase - if !isempty(adcLibrary) # Is this the best? maybe defining i=0 is better, it works with RFs(?) - a = adcLibrary[i]["data"] - else - a = [0,0,0,0,0] - end + a = adcLibrary[i]["data"] num = a[1] |> x->floor(Int64,x) dwell = a[2] delay = a[3] + dwell/2 @@ -684,10 +704,10 @@ function get_block(obj, i) A = read_ADC(obj["adcLibrary"], iadc) #DUR - D = [obj["blockDurations"][i]] + D = Float64[max(obj["blockDurations"][i], dur(Gx), dur(Gy), dur(Gz), dur(R), dur(A[1]))] #Extensions - E = Dict("extension"=>[iext]) #read_Extension(obj["extensionLibrary"], iext, i) + E = Dict{String, Any}()#read_Extension(obj["extensionLibrary"], iext, i) #Sequence block definition s = Sequence(G,R,A,D,E) diff --git a/KomaMRIFiles/test/Project.toml b/KomaMRIFiles/test/Project.toml index 6f86ac2e6..71e02ddbf 100644 --- a/KomaMRIFiles/test/Project.toml +++ b/KomaMRIFiles/test/Project.toml @@ -1,4 +1,7 @@ [deps] +KomaMRIBase = "d0bc0b20-b151-4d03-b2a4-6ca51751cb9c" +MAT = "23992714-dd62-5051-b70f-ba57cb901cac" +PrettyTables = "08abe8d2-0d0c-5749-adfa-8a2ac140af0d" Suppressor = "fd094767-a336-5f1f-9728-57cf17d0bbfb" Test = "8dfed614-e22c-5e08-85e1-65c5234f0b40" TestItemRunner = "f8b46487-2199-4994-9208-9a1283c18c0a" diff --git a/KomaMRIFiles/test/runtests.jl b/KomaMRIFiles/test/runtests.jl index 77195179d..a658fbd3e 100644 --- a/KomaMRIFiles/test/runtests.jl +++ b/KomaMRIFiles/test/runtests.jl @@ -49,3 +49,34 @@ using TestItems, TestItemRunner @test obj.name == "brain_mrilab.mat" end end + +@testitem "Pulseq compat" tags=[:files, :pulseq] begin + using MAT, KomaMRIBase, Suppressor + + # Aux functions + inside(x) = x[2:end-1] + namedtuple(x) = x[:] + namedtuple(d::Dict) = (; (Symbol(k == "df" ? "Δf" : k) => namedtuple(v) for (k,v) in d)...) + not_empty = ((ek, ep),) -> !isempty(ep.t) + + # Reading files + path = joinpath(@__DIR__, "test_files/pulseq_read_comparison") + pulseq_files = filter(endswith(".seq"), readdir(path)) .|> x -> splitext(x)[1] + for pulseq_file in pulseq_files + #@show pulseq_file + seq_koma = @suppress read_seq("$path/$pulseq_file.seq") + seq_pulseq = matread("$path/$pulseq_file.mat")["sequence"] .|> namedtuple + @testset "$pulseq_file" begin + for i in 1:length(seq_koma) + blk_koma = get_samples(seq_koma, i) + blk_pulseq = NamedTuple{keys(blk_koma)}(seq_pulseq[i]) # Reorder keys + for (ev_koma, ev_pulseq) in Iterators.filter(not_empty, zip(blk_koma, blk_pulseq)) + @test ev_koma.t ≈ ev_pulseq.t + @test inside(ev_koma.A) ≈ inside(ev_pulseq.A) + @test first(ev_koma.A) ≈ first(ev_pulseq.A) || ev_koma.t[2] ≈ ev_koma.t[1] + @test last(ev_koma.A) ≈ last(ev_pulseq.A) + end + end + end + end +end diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/epi.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/epi.mat new file mode 100644 index 000000000..866e5a4b3 Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/epi.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/epi.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/epi.seq new file mode 100644 index 000000000..8d405eea7 --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/epi.seq @@ -0,0 +1,3464 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name epi +RadiofrequencyRasterTime 1e-06 +TotalDuration 0.15405 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] + 1 319 1 0 0 1 0 0 + 2 80 0 2 3 4 0 0 + 3 68 0 5 0 0 1 0 + 4 6 0 0 6 0 0 0 + 5 68 0 7 0 0 1 0 + 6 6 0 0 6 0 0 0 + 7 68 0 5 0 0 1 0 + 8 6 0 0 6 0 0 0 + 9 68 0 7 0 0 1 0 + 10 6 0 0 6 0 0 0 + 11 68 0 5 0 0 1 0 + 12 6 0 0 6 0 0 0 + 13 68 0 7 0 0 1 0 + 14 6 0 0 6 0 0 0 + 15 68 0 5 0 0 1 0 + 16 6 0 0 6 0 0 0 + 17 68 0 7 0 0 1 0 + 18 6 0 0 6 0 0 0 + 19 68 0 5 0 0 1 0 + 20 6 0 0 6 0 0 0 + 21 68 0 7 0 0 1 0 + 22 6 0 0 6 0 0 0 + 23 68 0 5 0 0 1 0 + 24 6 0 0 6 0 0 0 + 25 68 0 7 0 0 1 0 + 26 6 0 0 6 0 0 0 + 27 68 0 5 0 0 1 0 + 28 6 0 0 6 0 0 0 + 29 68 0 7 0 0 1 0 + 30 6 0 0 6 0 0 0 + 31 68 0 5 0 0 1 0 + 32 6 0 0 6 0 0 0 + 33 68 0 7 0 0 1 0 + 34 6 0 0 6 0 0 0 + 35 68 0 5 0 0 1 0 + 36 6 0 0 6 0 0 0 + 37 68 0 7 0 0 1 0 + 38 6 0 0 6 0 0 0 + 39 68 0 5 0 0 1 0 + 40 6 0 0 6 0 0 0 + 41 68 0 7 0 0 1 0 + 42 6 0 0 6 0 0 0 + 43 68 0 5 0 0 1 0 + 44 6 0 0 6 0 0 0 + 45 68 0 7 0 0 1 0 + 46 6 0 0 6 0 0 0 + 47 68 0 5 0 0 1 0 + 48 6 0 0 6 0 0 0 + 49 68 0 7 0 0 1 0 + 50 6 0 0 6 0 0 0 + 51 68 0 5 0 0 1 0 + 52 6 0 0 6 0 0 0 + 53 68 0 7 0 0 1 0 + 54 6 0 0 6 0 0 0 + 55 68 0 5 0 0 1 0 + 56 6 0 0 6 0 0 0 + 57 68 0 7 0 0 1 0 + 58 6 0 0 6 0 0 0 + 59 68 0 5 0 0 1 0 + 60 6 0 0 6 0 0 0 + 61 68 0 7 0 0 1 0 + 62 6 0 0 6 0 0 0 + 63 68 0 5 0 0 1 0 + 64 6 0 0 6 0 0 0 + 65 68 0 7 0 0 1 0 + 66 6 0 0 6 0 0 0 + 67 68 0 5 0 0 1 0 + 68 6 0 0 6 0 0 0 + 69 68 0 7 0 0 1 0 + 70 6 0 0 6 0 0 0 + 71 68 0 5 0 0 1 0 + 72 6 0 0 6 0 0 0 + 73 68 0 7 0 0 1 0 + 74 6 0 0 6 0 0 0 + 75 68 0 5 0 0 1 0 + 76 6 0 0 6 0 0 0 + 77 68 0 7 0 0 1 0 + 78 6 0 0 6 0 0 0 + 79 68 0 5 0 0 1 0 + 80 6 0 0 6 0 0 0 + 81 68 0 7 0 0 1 0 + 82 6 0 0 6 0 0 0 + 83 68 0 5 0 0 1 0 + 84 6 0 0 6 0 0 0 + 85 68 0 7 0 0 1 0 + 86 6 0 0 6 0 0 0 + 87 68 0 5 0 0 1 0 + 88 6 0 0 6 0 0 0 + 89 68 0 7 0 0 1 0 + 90 6 0 0 6 0 0 0 + 91 68 0 5 0 0 1 0 + 92 6 0 0 6 0 0 0 + 93 68 0 7 0 0 1 0 + 94 6 0 0 6 0 0 0 + 95 68 0 5 0 0 1 0 + 96 6 0 0 6 0 0 0 + 97 68 0 7 0 0 1 0 + 98 6 0 0 6 0 0 0 + 99 68 0 5 0 0 1 0 +100 6 0 0 6 0 0 0 +101 68 0 7 0 0 1 0 +102 6 0 0 6 0 0 0 +103 68 0 5 0 0 1 0 +104 6 0 0 6 0 0 0 +105 68 0 7 0 0 1 0 +106 6 0 0 6 0 0 0 +107 68 0 5 0 0 1 0 +108 6 0 0 6 0 0 0 +109 68 0 7 0 0 1 0 +110 6 0 0 6 0 0 0 +111 68 0 5 0 0 1 0 +112 6 0 0 6 0 0 0 +113 68 0 7 0 0 1 0 +114 6 0 0 6 0 0 0 +115 68 0 5 0 0 1 0 +116 6 0 0 6 0 0 0 +117 68 0 7 0 0 1 0 +118 6 0 0 6 0 0 0 +119 68 0 5 0 0 1 0 +120 6 0 0 6 0 0 0 +121 68 0 7 0 0 1 0 +122 6 0 0 6 0 0 0 +123 68 0 5 0 0 1 0 +124 6 0 0 6 0 0 0 +125 68 0 7 0 0 1 0 +126 6 0 0 6 0 0 0 +127 68 0 5 0 0 1 0 +128 6 0 0 6 0 0 0 +129 68 0 7 0 0 1 0 +130 6 0 0 6 0 0 0 +131 319 2 0 0 1 0 0 +132 80 0 2 3 4 0 0 +133 68 0 5 0 0 1 0 +134 6 0 0 6 0 0 0 +135 68 0 7 0 0 1 0 +136 6 0 0 6 0 0 0 +137 68 0 5 0 0 1 0 +138 6 0 0 6 0 0 0 +139 68 0 7 0 0 1 0 +140 6 0 0 6 0 0 0 +141 68 0 5 0 0 1 0 +142 6 0 0 6 0 0 0 +143 68 0 7 0 0 1 0 +144 6 0 0 6 0 0 0 +145 68 0 5 0 0 1 0 +146 6 0 0 6 0 0 0 +147 68 0 7 0 0 1 0 +148 6 0 0 6 0 0 0 +149 68 0 5 0 0 1 0 +150 6 0 0 6 0 0 0 +151 68 0 7 0 0 1 0 +152 6 0 0 6 0 0 0 +153 68 0 5 0 0 1 0 +154 6 0 0 6 0 0 0 +155 68 0 7 0 0 1 0 +156 6 0 0 6 0 0 0 +157 68 0 5 0 0 1 0 +158 6 0 0 6 0 0 0 +159 68 0 7 0 0 1 0 +160 6 0 0 6 0 0 0 +161 68 0 5 0 0 1 0 +162 6 0 0 6 0 0 0 +163 68 0 7 0 0 1 0 +164 6 0 0 6 0 0 0 +165 68 0 5 0 0 1 0 +166 6 0 0 6 0 0 0 +167 68 0 7 0 0 1 0 +168 6 0 0 6 0 0 0 +169 68 0 5 0 0 1 0 +170 6 0 0 6 0 0 0 +171 68 0 7 0 0 1 0 +172 6 0 0 6 0 0 0 +173 68 0 5 0 0 1 0 +174 6 0 0 6 0 0 0 +175 68 0 7 0 0 1 0 +176 6 0 0 6 0 0 0 +177 68 0 5 0 0 1 0 +178 6 0 0 6 0 0 0 +179 68 0 7 0 0 1 0 +180 6 0 0 6 0 0 0 +181 68 0 5 0 0 1 0 +182 6 0 0 6 0 0 0 +183 68 0 7 0 0 1 0 +184 6 0 0 6 0 0 0 +185 68 0 5 0 0 1 0 +186 6 0 0 6 0 0 0 +187 68 0 7 0 0 1 0 +188 6 0 0 6 0 0 0 +189 68 0 5 0 0 1 0 +190 6 0 0 6 0 0 0 +191 68 0 7 0 0 1 0 +192 6 0 0 6 0 0 0 +193 68 0 5 0 0 1 0 +194 6 0 0 6 0 0 0 +195 68 0 7 0 0 1 0 +196 6 0 0 6 0 0 0 +197 68 0 5 0 0 1 0 +198 6 0 0 6 0 0 0 +199 68 0 7 0 0 1 0 +200 6 0 0 6 0 0 0 +201 68 0 5 0 0 1 0 +202 6 0 0 6 0 0 0 +203 68 0 7 0 0 1 0 +204 6 0 0 6 0 0 0 +205 68 0 5 0 0 1 0 +206 6 0 0 6 0 0 0 +207 68 0 7 0 0 1 0 +208 6 0 0 6 0 0 0 +209 68 0 5 0 0 1 0 +210 6 0 0 6 0 0 0 +211 68 0 7 0 0 1 0 +212 6 0 0 6 0 0 0 +213 68 0 5 0 0 1 0 +214 6 0 0 6 0 0 0 +215 68 0 7 0 0 1 0 +216 6 0 0 6 0 0 0 +217 68 0 5 0 0 1 0 +218 6 0 0 6 0 0 0 +219 68 0 7 0 0 1 0 +220 6 0 0 6 0 0 0 +221 68 0 5 0 0 1 0 +222 6 0 0 6 0 0 0 +223 68 0 7 0 0 1 0 +224 6 0 0 6 0 0 0 +225 68 0 5 0 0 1 0 +226 6 0 0 6 0 0 0 +227 68 0 7 0 0 1 0 +228 6 0 0 6 0 0 0 +229 68 0 5 0 0 1 0 +230 6 0 0 6 0 0 0 +231 68 0 7 0 0 1 0 +232 6 0 0 6 0 0 0 +233 68 0 5 0 0 1 0 +234 6 0 0 6 0 0 0 +235 68 0 7 0 0 1 0 +236 6 0 0 6 0 0 0 +237 68 0 5 0 0 1 0 +238 6 0 0 6 0 0 0 +239 68 0 7 0 0 1 0 +240 6 0 0 6 0 0 0 +241 68 0 5 0 0 1 0 +242 6 0 0 6 0 0 0 +243 68 0 7 0 0 1 0 +244 6 0 0 6 0 0 0 +245 68 0 5 0 0 1 0 +246 6 0 0 6 0 0 0 +247 68 0 7 0 0 1 0 +248 6 0 0 6 0 0 0 +249 68 0 5 0 0 1 0 +250 6 0 0 6 0 0 0 +251 68 0 7 0 0 1 0 +252 6 0 0 6 0 0 0 +253 68 0 5 0 0 1 0 +254 6 0 0 6 0 0 0 +255 68 0 7 0 0 1 0 +256 6 0 0 6 0 0 0 +257 68 0 5 0 0 1 0 +258 6 0 0 6 0 0 0 +259 68 0 7 0 0 1 0 +260 6 0 0 6 0 0 0 +261 319 3 0 0 1 0 0 +262 80 0 2 3 4 0 0 +263 68 0 5 0 0 1 0 +264 6 0 0 6 0 0 0 +265 68 0 7 0 0 1 0 +266 6 0 0 6 0 0 0 +267 68 0 5 0 0 1 0 +268 6 0 0 6 0 0 0 +269 68 0 7 0 0 1 0 +270 6 0 0 6 0 0 0 +271 68 0 5 0 0 1 0 +272 6 0 0 6 0 0 0 +273 68 0 7 0 0 1 0 +274 6 0 0 6 0 0 0 +275 68 0 5 0 0 1 0 +276 6 0 0 6 0 0 0 +277 68 0 7 0 0 1 0 +278 6 0 0 6 0 0 0 +279 68 0 5 0 0 1 0 +280 6 0 0 6 0 0 0 +281 68 0 7 0 0 1 0 +282 6 0 0 6 0 0 0 +283 68 0 5 0 0 1 0 +284 6 0 0 6 0 0 0 +285 68 0 7 0 0 1 0 +286 6 0 0 6 0 0 0 +287 68 0 5 0 0 1 0 +288 6 0 0 6 0 0 0 +289 68 0 7 0 0 1 0 +290 6 0 0 6 0 0 0 +291 68 0 5 0 0 1 0 +292 6 0 0 6 0 0 0 +293 68 0 7 0 0 1 0 +294 6 0 0 6 0 0 0 +295 68 0 5 0 0 1 0 +296 6 0 0 6 0 0 0 +297 68 0 7 0 0 1 0 +298 6 0 0 6 0 0 0 +299 68 0 5 0 0 1 0 +300 6 0 0 6 0 0 0 +301 68 0 7 0 0 1 0 +302 6 0 0 6 0 0 0 +303 68 0 5 0 0 1 0 +304 6 0 0 6 0 0 0 +305 68 0 7 0 0 1 0 +306 6 0 0 6 0 0 0 +307 68 0 5 0 0 1 0 +308 6 0 0 6 0 0 0 +309 68 0 7 0 0 1 0 +310 6 0 0 6 0 0 0 +311 68 0 5 0 0 1 0 +312 6 0 0 6 0 0 0 +313 68 0 7 0 0 1 0 +314 6 0 0 6 0 0 0 +315 68 0 5 0 0 1 0 +316 6 0 0 6 0 0 0 +317 68 0 7 0 0 1 0 +318 6 0 0 6 0 0 0 +319 68 0 5 0 0 1 0 +320 6 0 0 6 0 0 0 +321 68 0 7 0 0 1 0 +322 6 0 0 6 0 0 0 +323 68 0 5 0 0 1 0 +324 6 0 0 6 0 0 0 +325 68 0 7 0 0 1 0 +326 6 0 0 6 0 0 0 +327 68 0 5 0 0 1 0 +328 6 0 0 6 0 0 0 +329 68 0 7 0 0 1 0 +330 6 0 0 6 0 0 0 +331 68 0 5 0 0 1 0 +332 6 0 0 6 0 0 0 +333 68 0 7 0 0 1 0 +334 6 0 0 6 0 0 0 +335 68 0 5 0 0 1 0 +336 6 0 0 6 0 0 0 +337 68 0 7 0 0 1 0 +338 6 0 0 6 0 0 0 +339 68 0 5 0 0 1 0 +340 6 0 0 6 0 0 0 +341 68 0 7 0 0 1 0 +342 6 0 0 6 0 0 0 +343 68 0 5 0 0 1 0 +344 6 0 0 6 0 0 0 +345 68 0 7 0 0 1 0 +346 6 0 0 6 0 0 0 +347 68 0 5 0 0 1 0 +348 6 0 0 6 0 0 0 +349 68 0 7 0 0 1 0 +350 6 0 0 6 0 0 0 +351 68 0 5 0 0 1 0 +352 6 0 0 6 0 0 0 +353 68 0 7 0 0 1 0 +354 6 0 0 6 0 0 0 +355 68 0 5 0 0 1 0 +356 6 0 0 6 0 0 0 +357 68 0 7 0 0 1 0 +358 6 0 0 6 0 0 0 +359 68 0 5 0 0 1 0 +360 6 0 0 6 0 0 0 +361 68 0 7 0 0 1 0 +362 6 0 0 6 0 0 0 +363 68 0 5 0 0 1 0 +364 6 0 0 6 0 0 0 +365 68 0 7 0 0 1 0 +366 6 0 0 6 0 0 0 +367 68 0 5 0 0 1 0 +368 6 0 0 6 0 0 0 +369 68 0 7 0 0 1 0 +370 6 0 0 6 0 0 0 +371 68 0 5 0 0 1 0 +372 6 0 0 6 0 0 0 +373 68 0 7 0 0 1 0 +374 6 0 0 6 0 0 0 +375 68 0 5 0 0 1 0 +376 6 0 0 6 0 0 0 +377 68 0 7 0 0 1 0 +378 6 0 0 6 0 0 0 +379 68 0 5 0 0 1 0 +380 6 0 0 6 0 0 0 +381 68 0 7 0 0 1 0 +382 6 0 0 6 0 0 0 +383 68 0 5 0 0 1 0 +384 6 0 0 6 0 0 0 +385 68 0 7 0 0 1 0 +386 6 0 0 6 0 0 0 +387 68 0 5 0 0 1 0 +388 6 0 0 6 0 0 0 +389 68 0 7 0 0 1 0 +390 6 0 0 6 0 0 0 + +# Format of RF events: +# id amplitude mag_id phase_id time_shape_id delay freq phase +# .. Hz .... .... .... us Hz rad +[RF] +1 329.152 1 2 0 100 -1333.33 0 +2 329.152 1 2 0 100 0 0 +3 329.152 1 2 0 100 1333.33 0 + +# Format of trapezoid gradients: +# id amplitude rise flat fall delay +# .. Hz/m us us us us +[TRAP] + 1 444444 90 3000 90 10 + 2 -365816 70 660 70 0 + 3 -191388 40 720 40 0 + 4 -1.18391e+06 220 360 220 0 + 5 1.13636e+06 210 260 210 0 + 6 151515 30 0 30 0 + 7 -1.13636e+06 210 260 210 0 + +# Format of ADC events: +# id num dwell delay freq phase +# .. .. ns us Hz rad +[ADC] +1 64 4000 214 0 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 3000 +9.14157145e-11 +2.46985517e-09 +1.14419998e-08 +3.14172076e-08 +6.68159063e-08 +1.22069341e-07 +2.01619321e-07 +3.09917965e-07 +4.51427445e-07 +6.30619731e-07 +8.51976334e-07 +1.11998804e-06 +1.43915468e-06 +1.81398481e-06 +2.24899552e-06 +2.74871213e-06 +3.31766794e-06 +3.96040395e-06 +4.68146863e-06 +5.48541761e-06 +6.37681346e-06 +7.36022539e-06 +8.44022899e-06 +9.62140598e-06 +1.09083439e-05 +1.23056359e-05 +1.38178804e-05 +1.54496809e-05 +1.72056456e-05 +1.90903871e-05 +2.11085226e-05 +2.32646727e-05 +2.5563462e-05 +2.80095185e-05 +3.06074732e-05 +3.33619599e-05 +3.6277615e-05 +3.93590773e-05 +4.26109873e-05 +4.60379876e-05 +4.96447219e-05 +5.34358353e-05 +5.74159736e-05 +6.15897832e-05 +6.59619109e-05 +7.05370036e-05 +7.53197076e-05 +8.0314669e-05 +8.5526533e-05 +9.09599435e-05 +9.66195432e-05 +0.000102509973 +0.000108635872 +0.000115001876 +0.000121612621 +0.000128472737 +0.000135586852 +0.000142959591 +0.000150595575 +0.000158499421 +0.000166675742 +0.000175129145 +0.000183864235 +0.00019288561 +0.000202197861 +0.000211805575 +0.000221713335 +0.000231925713 +0.000242447278 +0.000253282591 +0.000264436206 +0.000275912667 +0.000287716515 +0.000299852279 +0.000312324481 +0.000325137633 +0.000338296241 +0.000351804799 +0.000365667792 +0.000379889695 +0.000394474974 +0.000409428083 +0.000424753467 +0.000440455557 +0.000456538775 +0.000473007532 +0.000489866224 +0.000507119238 +0.000524770946 +0.000542825708 +0.000561287871 +0.000580161769 +0.000599451722 +0.000619162034 +0.000639296997 +0.000659860888 +0.000680857968 +0.000702292483 +0.000724168666 +0.000746490729 +0.000769262873 +0.000792489279 +0.000816174114 +0.000840321525 +0.000864935645 +0.000890020586 +0.000915580444 +0.000941619297 +0.000968141203 +0.000995150203 +0.00102265032 +0.00105064555 +0.00107913988 +0.00110813726 +0.00113764165 +0.00116765696 +0.00119818709 +0.00122923593 +0.00126080731 +0.0012929051 +0.00132553309 +0.00135869507 +0.00139239482 +0.00142663608 +0.00146142258 +0.001496758 +0.00153264603 +0.00156909032 +0.00160609449 +0.00164366214 +0.00168179686 +0.00172050218 +0.00175978164 +0.00179963874 +0.00184007694 +0.0018810997 +0.00192271043 +0.00196491254 +0.00200770937 +0.00205110429 +0.00209510058 +0.00213970154 +0.00218491041 +0.00223073043 +0.00227716478 +0.00232421664 +0.00237188914 +0.00242018539 +0.00246910847 +0.00251866141 +0.00256884724 +0.00261966894 +0.00267112947 +0.00272323174 +0.00277597864 +0.00282937304 +0.00288341775 +0.00293811558 +0.00299346927 +0.00304948156 +0.00310615513 +0.00316349266 +0.00322149675 +0.00328017001 +0.00333951498 +0.00339953419 +0.00346023013 +0.00352160525 +0.00358366195 +0.00364640262 +0.00370982961 +0.00377394521 +0.0038387517 +0.00390425132 +0.00397044624 +0.00403733864 +0.00410493063 +0.0041732243 +0.00424222169 +0.0043119248 +0.0043823356 +0.00445345601 +0.00452528793 +0.00459783321 +0.00467109365 +0.00474507101 +0.00481976704 +0.00489518341 +0.00497132178 +0.00504818374 +0.00512577087 +0.00520408468 +0.00528312666 +0.00536289824 +0.00544340083 +0.00552463578 +0.00560660439 +0.00568930794 +0.00577274766 +0.00585692471 +0.00594184025 +0.00602749537 +0.00611389112 +0.00620102849 +0.00628890846 +0.00637753194 +0.0064668998 +0.00655701287 +0.00664787193 +0.00673947771 +0.0068318309 +0.00692493214 +0.00701878203 +0.00711338112 +0.00720872992 +0.00730482887 +0.00740167838 +0.00749927883 +0.00759763052 +0.00769673371 +0.00779658862 +0.00789719543 +0.00799855425 +0.00810066516 +0.00820352817 +0.00830714327 +0.00841151037 +0.00851662936 +0.00862250005 +0.00872912223 +0.00883649561 +0.00894461988 +0.00905349466 +0.00916311953 +0.009273494 +0.00938461754 +0.00949648959 +0.00960910951 +0.00972247662 +0.00983659019 +0.00995144942 +0.0100670535 +0.0101834015 +0.0103004925 +0.0104183255 +0.0105368995 +0.0106562134 +0.0107762659 +0.0108970559 +0.0110185822 +0.0111408434 +0.0112638382 +0.0113875651 +0.0115120227 +0.0116372094 +0.0117631237 +0.0118897639 +0.0120171282 +0.0121452151 +0.0122740227 +0.012403549 +0.0125337923 +0.0126647504 +0.0127964215 +0.0129288035 +0.0130618941 +0.0131956912 +0.0133301926 +0.013465396 +0.0136012989 +0.013737899 +0.0138751939 +0.0140131809 +0.0141518575 +0.0142912211 +0.0144312689 +0.0145719983 +0.0147134063 +0.0148554902 +0.0149982469 +0.0151416736 +0.0152857671 +0.0154305243 +0.0155759422 +0.0157220175 +0.0158687469 +0.0160161271 +0.0161641547 +0.0163128262 +0.0164621382 +0.016612087 +0.0167626691 +0.0169138808 +0.0170657182 +0.0172181778 +0.0173712555 +0.0175249474 +0.0176792496 +0.0178341581 +0.0179896688 +0.0181457774 +0.0183024798 +0.0184597717 +0.0186176488 +0.0187761068 +0.018935141 +0.0190947471 +0.0192549205 +0.0194156565 +0.0195769504 +0.0197387976 +0.0199011931 +0.0200641322 +0.0202276099 +0.0203916212 +0.0205561611 +0.0207212245 +0.0208868062 +0.0210529009 +0.0212195035 +0.0213866084 +0.0215542105 +0.0217223041 +0.0218908838 +0.0220599439 +0.0222294789 +0.022399483 +0.0225699504 +0.0227408754 +0.022912252 +0.0230840744 +0.0232563364 +0.023429032 +0.0236021552 +0.0237756997 +0.0239496593 +0.0241240276 +0.0242987984 +0.0244739651 +0.0246495214 +0.0248254606 +0.0250017762 +0.0251784614 +0.0253555097 +0.0255329141 +0.0257106678 +0.025888764 +0.0260671957 +0.0262459559 +0.0264250374 +0.0266044332 +0.026784136 +0.0269641386 +0.0271444336 +0.0273250137 +0.0275058715 +0.0276869995 +0.02786839 +0.0280500355 +0.0282319284 +0.0284140608 +0.028596425 +0.0287790131 +0.0289618173 +0.0291448296 +0.0293280419 +0.0295114461 +0.0296950342 +0.0298787979 +0.030062729 +0.0302468191 +0.0304310599 +0.0306154429 +0.0307999597 +0.0309846017 +0.0311693603 +0.0313542268 +0.0315391926 +0.0317242489 +0.0319093867 +0.0320945973 +0.0322798717 +0.0324652008 +0.0326505757 +0.0328359871 +0.033021426 +0.0332068831 +0.0333923492 +0.0335778148 +0.0337632706 +0.0339487071 +0.0341341149 +0.0343194843 +0.0345048057 +0.0346900696 +0.034875266 +0.0350603854 +0.0352454177 +0.0354303533 +0.035615182 +0.0357998938 +0.0359844789 +0.0361689269 +0.0363532278 +0.0365373714 +0.0367213474 +0.0369051454 +0.0370887552 +0.0372721662 +0.037455368 +0.0376383501 +0.0378211018 +0.0380036126 +0.0381858718 +0.0383678685 +0.0385495921 +0.0387310317 +0.0389121764 +0.0390930153 +0.0392735373 +0.0394537315 +0.0396335866 +0.0398130917 +0.0399922355 +0.0401710067 +0.0403493941 +0.0405273863 +0.040704972 +0.0408821396 +0.0410588778 +0.0412351749 +0.0414110195 +0.0415863998 +0.0417613042 +0.041935721 +0.0421096384 +0.0422830446 +0.0424559277 +0.0426282758 +0.042800077 +0.0429713192 +0.0431419904 +0.0433120786 +0.0434815715 +0.0436504571 +0.043818723 +0.043986357 +0.0441533468 +0.0443196801 +0.0444853444 +0.0446503273 +0.0448146163 +0.0449781989 +0.0451410625 +0.0453031945 +0.0454645823 +0.0456252131 +0.0457850743 +0.045944153 +0.0461024364 +0.0462599117 +0.0464165659 +0.0465723862 +0.0467273596 +0.046881473 +0.0470347135 +0.0471870678 +0.0473385229 +0.0474890656 +0.0476386828 +0.0477873611 +0.0479350873 +0.0480818481 +0.0482276301 +0.0483724199 +0.0485162042 +0.0486589695 +0.0488007022 +0.0489413889 +0.049081016 +0.0492195698 +0.0493570369 +0.0494934035 +0.0496286559 +0.0497627804 +0.0498957632 +0.0500275906 +0.0501582488 +0.0502877238 +0.0504160018 +0.050543069 +0.0506689113 +0.0507935148 +0.0509168654 +0.0510389492 +0.0511597522 +0.0512792601 +0.051397459 +0.0515143346 +0.0516298728 +0.0517440594 +0.0518568802 +0.0519683209 +0.0520783673 +0.052187005 +0.0522942199 +0.0523999974 +0.0525043232 +0.052607183 +0.0527085623 +0.0528084467 +0.0529068218 +0.0530036729 +0.0530989857 +0.0531927456 +0.0532849381 +0.0533755486 +0.0534645625 +0.0535519652 +0.0536377421 +0.0537218785 +0.0538043597 +0.0538851712 +0.0539642981 +0.0540417258 +0.0541174396 +0.0541914246 +0.0542636662 +0.0543341495 +0.0544028598 +0.0544697821 +0.0545349019 +0.054598204 +0.0546596738 +0.0547192964 +0.0547770568 +0.0548329402 +0.0548869318 +0.0549390164 +0.0549891794 +0.0550374056 +0.0550836803 +0.0551279883 +0.0551703148 +0.0552106448 +0.0552489633 +0.0552852554 +0.0553195059 +0.0553517 +0.0553818226 +0.0554098587 +0.0554357933 +0.0554596113 +0.0554812978 +0.0555008376 +0.0555182158 +0.0555334174 +0.0555464272 +0.0555572302 +0.0555658114 +0.0555721558 +0.0555762482 +0.0555780737 +0.0555776171 +0.0555748635 +0.0555697977 +0.0555624048 +0.0555526697 +0.0555405773 +0.0555261126 +0.0555092605 +0.0554900061 +0.0554683342 +0.05544423 +0.0554176782 +0.055388664 +0.0553571723 +0.0553231882 +0.0552866965 +0.0552476823 +0.0552061307 +0.0551620267 +0.0551153553 +0.0550661015 +0.0550142504 +0.0549597871 +0.0549026966 +0.0548429641 +0.0547805746 +0.0547155132 +0.0546477651 +0.0545773154 +0.0545041492 +0.0544282517 +0.0543496081 +0.0542682036 +0.0541840233 +0.0540970526 +0.0540072766 +0.0539146807 +0.05381925 +0.0537209699 +0.0536198256 +0.0535158026 +0.0534088862 +0.0532990617 +0.0531863145 +0.05307063 +0.0529519938 +0.0528303911 +0.0527058076 +0.0525782286 +0.0524476398 +0.0523140266 +0.0521773747 +0.0520376696 +0.051894897 +0.0517490425 +0.0516000917 +0.0514480304 +0.0512928443 +0.0511345192 +0.0509730408 +0.050808395 +0.0506405675 +0.0504695443 +0.0502953113 +0.0501178543 +0.0499371594 +0.0497532126 +0.0495659998 +0.0493755072 +0.0491817207 +0.0489846267 +0.0487842111 +0.0485804603 +0.0483733603 +0.0481628976 +0.0479490584 +0.047731829 +0.0475111958 +0.0472871453 +0.0470596638 +0.0468287379 +0.0465943541 +0.0463564989 +0.0461151591 +0.0458703211 +0.0456219717 +0.0453700977 +0.0451146858 +0.0448557228 +0.0445931957 +0.0443270912 +0.0440573963 +0.0437840981 +0.0435071835 +0.0432266396 +0.0429424537 +0.0426546128 +0.0423631041 +0.042067915 +0.0417690327 +0.0414664446 +0.0411601381 +0.0408501008 +0.04053632 +0.0402187834 +0.0398974785 +0.0395723931 +0.0392435149 +0.0389108315 +0.0385743309 +0.0382340009 +0.0378898295 +0.0375418045 +0.0371899142 +0.0368341464 +0.0364744895 +0.0361109316 +0.0357434609 +0.0353720658 +0.0349967347 +0.0346174559 +0.034234218 +0.0338470096 +0.0334558191 +0.0330606354 +0.0326614471 +0.032258243 +0.031851012 +0.0314397429 +0.0310244248 +0.0306050467 +0.0301815977 +0.0297540669 +0.0293224436 +0.0288867171 +0.0284468767 +0.0280029119 +0.0275548121 +0.0271025669 +0.0266461659 +0.0261855988 +0.0257208553 +0.0252519254 +0.0247787988 +0.0243014655 +0.0238199156 +0.0233341392 +0.0228441264 +0.0223498675 +0.0218513527 +0.0213485726 +0.0208415174 +0.0203301778 +0.0198145444 +0.0192946078 +0.0187703588 +0.0182417882 +0.0177088869 +0.0171716458 +0.0166300561 +0.0160841088 +0.0155337952 +0.0149791065 +0.0144200341 +0.0138565694 +0.0132887039 +0.0127164292 +0.0121397369 +0.0115586189 +0.010973067 +0.010383073 +0.00978862891 +0.00918972685 +0.00858635895 +0.00797851743 +0.0073661946 +0.00674938288 +0.00612807472 +0.0055022627 +0.00487193946 +0.00423709772 +0.00359773031 +0.00295383012 +0.00230539013 +0.00165240341 +0.000994863129 +0.000332762517 +0.000333905094 +0.00100514629 +0.00168096756 +0.00236137532 +0.00304637589 +0.0037359755 +0.00443018029 +0.00512899631 +0.00583242953 +0.00654048582 +0.00725317096 +0.00797049065 +0.00869245048 +0.00941905596 +0.0101503125 +0.0108862255 +0.0116268 +0.0123720414 +0.0131219545 +0.0138765444 +0.014635816 +0.0153997739 +0.0161684229 +0.0169417674 +0.0177198121 +0.0185025613 +0.0192900193 +0.0200821902 +0.0208790782 +0.0216806872 +0.0224870212 +0.0232980839 +0.0241138791 +0.0249344104 +0.0257596812 +0.026589695 +0.0274244551 +0.0282639647 +0.0291082269 +0.0299572447 +0.030811021 +0.0316695587 +0.0325328604 +0.0334009287 +0.0342737662 +0.0351513753 +0.0360337582 +0.0369209171 +0.0378128542 +0.0387095715 +0.0396110707 +0.0405173538 +0.0414284224 +0.042344278 +0.0432649222 +0.0441903564 +0.0451205816 +0.0460555993 +0.0469954103 +0.0479400157 +0.0488894162 +0.0498436127 +0.0508026057 +0.0517663958 +0.0527349834 +0.0537083688 +0.0546865522 +0.0556695337 +0.0566573133 +0.0576498908 +0.0586472661 +0.0596494388 +0.0606564085 +0.0616681745 +0.0626847363 +0.0637060931 +0.0647322439 +0.0657631878 +0.0667989237 +0.0678394504 +0.0688847666 +0.0699348708 +0.0709897614 +0.0720494369 +0.0731138955 +0.0741831353 +0.0752571542 +0.0763359503 +0.0774195212 +0.0785078648 +0.0796009785 +0.0806988597 +0.0818015059 +0.0829089143 +0.084021082 +0.0851380059 +0.0862596831 +0.0873861102 +0.0885172839 +0.0896532008 +0.0907938573 +0.0919392497 +0.0930893743 +0.0942442272 +0.0954038042 +0.0965681014 +0.0977371144 +0.0989108389 +0.10008927 +0.101272404 +0.102460236 +0.103652761 +0.104849973 +0.106051869 +0.107258442 +0.108469688 +0.109685601 +0.110906175 +0.112131406 +0.113361286 +0.114595811 +0.115834975 +0.11707877 +0.118327192 +0.119580234 +0.120837889 +0.12210015 +0.123367012 +0.124638468 +0.125914509 +0.12719513 +0.128480324 +0.129770083 +0.131064399 +0.132363265 +0.133666674 +0.134974618 +0.136287089 +0.13760408 +0.138925581 +0.140251585 +0.141582084 +0.142917069 +0.144256532 +0.145600464 +0.146948856 +0.148301699 +0.149658985 +0.151020704 +0.152386847 +0.153757405 +0.155132369 +0.156511727 +0.157895472 +0.159283593 +0.160676081 +0.162072924 +0.163474114 +0.16487964 +0.16628949 +0.167703656 +0.169122126 +0.17054489 +0.171971936 +0.173403254 +0.174838833 +0.176278661 +0.177722727 +0.17917102 +0.180623529 +0.18208024 +0.183541144 +0.185006227 +0.186475478 +0.187948885 +0.189426435 +0.190908116 +0.192393916 +0.193883822 +0.195377822 +0.196875902 +0.198378049 +0.199884252 +0.201394495 +0.202908767 +0.204427054 +0.205949342 +0.207475618 +0.209005867 +0.210540077 +0.212078233 +0.213620321 +0.215166328 +0.216716237 +0.218270037 +0.219827711 +0.221389245 +0.222954624 +0.224523835 +0.22609686 +0.227673687 +0.229254299 +0.23083868 +0.232426817 +0.234018693 +0.235614292 +0.237213599 +0.238816598 +0.240423274 +0.242033609 +0.243647588 +0.245265195 +0.246886412 +0.248511225 +0.250139615 +0.251771567 +0.253407063 +0.255046087 +0.256688621 +0.258334649 +0.259984153 +0.261637116 +0.26329352 +0.264953348 +0.266616581 +0.268283204 +0.269953196 +0.271626541 +0.27330322 +0.274983216 +0.276666509 +0.278353081 +0.280042915 +0.28173599 +0.28343229 +0.285131794 +0.286834483 +0.28854034 +0.290249344 +0.291961476 +0.293676717 +0.295395048 +0.297116449 +0.298840901 +0.300568383 +0.302298875 +0.304032359 +0.305768814 +0.307508219 +0.309250555 +0.310995801 +0.312743936 +0.314494941 +0.316248795 +0.318005476 +0.319764964 +0.321527238 +0.323292277 +0.32506006 +0.326830566 +0.328603774 +0.330379661 +0.332158207 +0.33393939 +0.335723188 +0.33750958 +0.339298543 +0.341090057 +0.342884097 +0.344680644 +0.346479673 +0.348281164 +0.350085093 +0.351891438 +0.353700177 +0.355511287 +0.357324745 +0.359140527 +0.360958613 +0.362778977 +0.364601597 +0.366426451 +0.368253514 +0.370082763 +0.371914175 +0.373747726 +0.375583393 +0.377421152 +0.379260979 +0.38110285 +0.382946742 +0.384792629 +0.386640489 +0.388490297 +0.390342028 +0.392195659 +0.394051164 +0.39590852 +0.397767701 +0.399628683 +0.401491442 +0.403355952 +0.405222188 +0.407090126 +0.40895974 +0.410831006 +0.412703898 +0.41457839 +0.416454458 +0.418332076 +0.420211218 +0.422091859 +0.423973974 +0.425857536 +0.427742519 +0.429628898 +0.431516648 +0.433405741 +0.435296151 +0.437187854 +0.439080822 +0.440975029 +0.442870449 +0.444767055 +0.446664821 +0.44856372 +0.450463727 +0.452364813 +0.454266952 +0.456170119 +0.458074284 +0.459979423 +0.461885507 +0.46379251 +0.465700404 +0.467609163 +0.46951876 +0.471429166 +0.473340354 +0.475252298 +0.477164969 +0.479078341 +0.480992385 +0.482907074 +0.484822381 +0.486738277 +0.488654735 +0.490571727 +0.492489225 +0.494407201 +0.496325627 +0.498244475 +0.500163717 +0.502083325 +0.504003271 +0.505923526 +0.507844062 +0.50976485 +0.511685864 +0.513607073 +0.515528449 +0.517449965 +0.519371591 +0.521293298 +0.523215059 +0.525136844 +0.527058625 +0.528980373 +0.530902059 +0.532823654 +0.534745129 +0.536666456 +0.538587605 +0.540508548 +0.542429255 +0.544349698 +0.546269846 +0.548189672 +0.550109146 +0.552028238 +0.55394692 +0.555865161 +0.557782934 +0.559700208 +0.561616954 +0.563533143 +0.565448745 +0.567363731 +0.569278071 +0.571191736 +0.573104696 +0.575016922 +0.576928383 +0.578839052 +0.580748897 +0.582657889 +0.584565999 +0.586473196 +0.588379452 +0.590284735 +0.592189018 +0.594092269 +0.595994458 +0.597895557 +0.599795535 +0.601694363 +0.60359201 +0.605488446 +0.607383643 +0.609277569 +0.611170195 +0.613061491 +0.614951426 +0.616839972 +0.618727098 +0.620612773 +0.622496969 +0.624379655 +0.626260801 +0.628140376 +0.630018352 +0.631894697 +0.633769383 +0.635642378 +0.637513653 +0.639383178 +0.641250922 +0.643116856 +0.64498095 +0.646843173 +0.648703496 +0.650561888 +0.652418319 +0.65427276 +0.65612518 +0.657975549 +0.659823837 +0.661670015 +0.663514052 +0.665355917 +0.667195582 +0.669033016 +0.670868189 +0.672701071 +0.674531632 +0.676359843 +0.678185672 +0.680009091 +0.68183007 +0.683648577 +0.685464584 +0.687278061 +0.689088977 +0.690897304 +0.69270301 +0.694506067 +0.696306444 +0.698104112 +0.69989904 +0.7016912 +0.703480561 +0.705267094 +0.707050769 +0.708831556 +0.710609426 +0.712384349 +0.714156295 +0.715925236 +0.717691141 +0.719453981 +0.721213726 +0.722970348 +0.724723816 +0.726474101 +0.728221174 +0.729965006 +0.731705567 +0.733442827 +0.735176759 +0.736907332 +0.738634517 +0.740358286 +0.742078609 +0.743795457 +0.745508801 +0.747218612 +0.748924862 +0.75062752 +0.75232656 +0.75402195 +0.755713664 +0.757401672 +0.759085945 +0.760766455 +0.762443173 +0.76411607 +0.765785119 +0.767450291 +0.769111556 +0.770768888 +0.772422257 +0.774071635 +0.775716994 +0.777358306 +0.778995543 +0.780628676 +0.782257678 +0.783882521 +0.785503177 +0.787119617 +0.788731814 +0.790339741 +0.79194337 +0.793542672 +0.795137621 +0.796728189 +0.798314348 +0.799896071 +0.801473331 +0.803046101 +0.804614353 +0.806178059 +0.807737194 +0.80929173 +0.81084164 +0.812386896 +0.813927473 +0.815463344 +0.816994481 +0.818520858 +0.820042449 +0.821559227 +0.823071166 +0.824578239 +0.82608042 +0.827577682 +0.829070001 +0.830557348 +0.8320397 +0.833517029 +0.83498931 +0.836456516 +0.837918623 +0.839375605 +0.840827436 +0.84227409 +0.843715543 +0.845151769 +0.846582742 +0.848008438 +0.849428831 +0.850843897 +0.85225361 +0.853657947 +0.855056881 +0.856450388 +0.857838444 +0.859221024 +0.860598104 +0.86196966 +0.863335667 +0.8646961 +0.866050937 +0.867400153 +0.868743724 +0.870081627 +0.871413837 +0.872740331 +0.874061086 +0.875376077 +0.876685283 +0.877988679 +0.879286242 +0.880577949 +0.881863778 +0.883143705 +0.884417708 +0.885685764 +0.88694785 +0.888203944 +0.889454023 +0.890698066 +0.891936049 +0.893167952 +0.894393751 +0.895613425 +0.896826953 +0.898034312 +0.899235481 +0.900430438 +0.901619162 +0.902801633 +0.903977827 +0.905147725 +0.906311306 +0.907468549 +0.908619432 +0.909763936 +0.910902039 +0.912033722 +0.913158963 +0.914277744 +0.915390043 +0.91649584 +0.917595117 +0.918687852 +0.919774027 +0.920853621 +0.921926616 +0.922992992 +0.924052729 +0.925105809 +0.926152213 +0.927191922 +0.928224916 +0.929251178 +0.930270689 +0.93128343 +0.932289384 +0.933288531 +0.934280854 +0.935266336 +0.936244957 +0.937216701 +0.938181549 +0.939139485 +0.940090491 +0.94103455 +0.941971645 +0.942901758 +0.943824873 +0.944740973 +0.945650041 +0.946552062 +0.947447018 +0.948334894 +0.949215673 +0.950089339 +0.950955876 +0.951815269 +0.952667502 +0.95351256 +0.954350427 +0.955181087 +0.956004527 +0.95682073 +0.957629682 +0.958431369 +0.959225775 +0.960012886 +0.960792688 +0.961565167 +0.962330308 +0.963088097 +0.963838522 +0.964581567 +0.965317221 +0.966045468 +0.966766296 +0.967479691 +0.968185641 +0.968884133 +0.969575154 +0.970258692 +0.970934733 +0.971603265 +0.972264277 +0.972917756 +0.97356369 +0.974202068 +0.974832878 +0.975456107 +0.976071746 +0.976679782 +0.977280204 +0.977873002 +0.978458164 +0.979035681 +0.97960554 +0.980167733 +0.980722247 +0.981269075 +0.981808204 +0.982339626 +0.982863331 +0.983379309 +0.98388755 +0.984388046 +0.984880787 +0.985365764 +0.985842968 +0.986312391 +0.986774023 +0.987227857 +0.987673884 +0.988112096 +0.988542484 +0.988965042 +0.98937976 +0.989786632 +0.99018565 +0.990576807 +0.990960095 +0.991335508 +0.991703038 +0.992062679 +0.992414424 +0.992758267 +0.993094202 +0.993422222 +0.99374232 +0.994054493 +0.994358732 +0.994655034 +0.994943392 +0.995223802 +0.995496257 +0.995760754 +0.996017287 +0.996265851 +0.996506442 +0.996739055 +0.996963687 +0.997180333 +0.997388989 +0.997589651 +0.997782315 +0.997966979 +0.998143638 +0.998312289 +0.99847293 +0.998625557 +0.998770167 +0.998906758 +0.999035327 +0.999155873 +0.999268391 +0.999372882 +0.999469342 +0.99955777 +0.999638164 +0.999710524 +0.999774846 +0.999831131 +0.999879377 +0.999919583 +0.999951749 +0.999975875 +0.999991958 +1 +1 +0.999991958 +0.999975875 +0.999951749 +0.999919583 +0.999879377 +0.999831131 +0.999774846 +0.999710524 +0.999638164 +0.99955777 +0.999469342 +0.999372882 +0.999268391 +0.999155873 +0.999035327 +0.998906758 +0.998770167 +0.998625557 +0.99847293 +0.998312289 +0.998143638 +0.997966979 +0.997782315 +0.997589651 +0.997388989 +0.997180333 +0.996963687 +0.996739055 +0.996506442 +0.996265851 +0.996017287 +0.995760754 +0.995496257 +0.995223802 +0.994943392 +0.994655034 +0.994358732 +0.994054493 +0.99374232 +0.993422222 +0.993094202 +0.992758267 +0.992414424 +0.992062679 +0.991703038 +0.991335508 +0.990960095 +0.990576807 +0.99018565 +0.989786632 +0.98937976 +0.988965042 +0.988542484 +0.988112096 +0.987673884 +0.987227857 +0.986774023 +0.986312391 +0.985842968 +0.985365764 +0.984880787 +0.984388046 +0.98388755 +0.983379309 +0.982863331 +0.982339626 +0.981808204 +0.981269075 +0.980722247 +0.980167733 +0.97960554 +0.979035681 +0.978458164 +0.977873002 +0.977280204 +0.976679782 +0.976071746 +0.975456107 +0.974832878 +0.974202068 +0.97356369 +0.972917756 +0.972264277 +0.971603265 +0.970934733 +0.970258692 +0.969575154 +0.968884133 +0.968185641 +0.967479691 +0.966766296 +0.966045468 +0.965317221 +0.964581567 +0.963838522 +0.963088097 +0.962330308 +0.961565167 +0.960792688 +0.960012886 +0.959225775 +0.958431369 +0.957629682 +0.95682073 +0.956004527 +0.955181087 +0.954350427 +0.95351256 +0.952667502 +0.951815269 +0.950955876 +0.950089339 +0.949215673 +0.948334894 +0.947447018 +0.946552062 +0.945650041 +0.944740973 +0.943824873 +0.942901758 +0.941971645 +0.94103455 +0.940090491 +0.939139485 +0.938181549 +0.937216701 +0.936244957 +0.935266336 +0.934280854 +0.933288531 +0.932289384 +0.93128343 +0.930270689 +0.929251178 +0.928224916 +0.927191922 +0.926152213 +0.925105809 +0.924052729 +0.922992992 +0.921926616 +0.920853621 +0.919774027 +0.918687852 +0.917595117 +0.91649584 +0.915390043 +0.914277744 +0.913158963 +0.912033722 +0.910902039 +0.909763936 +0.908619432 +0.907468549 +0.906311306 +0.905147725 +0.903977827 +0.902801633 +0.901619162 +0.900430438 +0.899235481 +0.898034312 +0.896826953 +0.895613425 +0.894393751 +0.893167952 +0.891936049 +0.890698066 +0.889454023 +0.888203944 +0.88694785 +0.885685764 +0.884417708 +0.883143705 +0.881863778 +0.880577949 +0.879286242 +0.877988679 +0.876685283 +0.875376077 +0.874061086 +0.872740331 +0.871413837 +0.870081627 +0.868743724 +0.867400153 +0.866050937 +0.8646961 +0.863335667 +0.86196966 +0.860598104 +0.859221024 +0.857838444 +0.856450388 +0.855056881 +0.853657947 +0.85225361 +0.850843897 +0.849428831 +0.848008438 +0.846582742 +0.845151769 +0.843715543 +0.84227409 +0.840827436 +0.839375605 +0.837918623 +0.836456516 +0.83498931 +0.833517029 +0.8320397 +0.830557348 +0.829070001 +0.827577682 +0.82608042 +0.824578239 +0.823071166 +0.821559227 +0.820042449 +0.818520858 +0.816994481 +0.815463344 +0.813927473 +0.812386896 +0.81084164 +0.80929173 +0.807737194 +0.806178059 +0.804614353 +0.803046101 +0.801473331 +0.799896071 +0.798314348 +0.796728189 +0.795137621 +0.793542672 +0.79194337 +0.790339741 +0.788731814 +0.787119617 +0.785503177 +0.783882521 +0.782257678 +0.780628676 +0.778995543 +0.777358306 +0.775716994 +0.774071635 +0.772422257 +0.770768888 +0.769111556 +0.767450291 +0.765785119 +0.76411607 +0.762443173 +0.760766455 +0.759085945 +0.757401672 +0.755713664 +0.75402195 +0.75232656 +0.75062752 +0.748924862 +0.747218612 +0.745508801 +0.743795457 +0.742078609 +0.740358286 +0.738634517 +0.736907332 +0.735176759 +0.733442827 +0.731705567 +0.729965006 +0.728221174 +0.726474101 +0.724723816 +0.722970348 +0.721213726 +0.719453981 +0.717691141 +0.715925236 +0.714156295 +0.712384349 +0.710609426 +0.708831556 +0.707050769 +0.705267094 +0.703480561 +0.7016912 +0.69989904 +0.698104112 +0.696306444 +0.694506067 +0.69270301 +0.690897304 +0.689088977 +0.687278061 +0.685464584 +0.683648577 +0.68183007 +0.680009091 +0.678185672 +0.676359843 +0.674531632 +0.672701071 +0.670868189 +0.669033016 +0.667195582 +0.665355917 +0.663514052 +0.661670015 +0.659823837 +0.657975549 +0.65612518 +0.65427276 +0.652418319 +0.650561888 +0.648703496 +0.646843173 +0.64498095 +0.643116856 +0.641250922 +0.639383178 +0.637513653 +0.635642378 +0.633769383 +0.631894697 +0.630018352 +0.628140376 +0.626260801 +0.624379655 +0.622496969 +0.620612773 +0.618727098 +0.616839972 +0.614951426 +0.613061491 +0.611170195 +0.609277569 +0.607383643 +0.605488446 +0.60359201 +0.601694363 +0.599795535 +0.597895557 +0.595994458 +0.594092269 +0.592189018 +0.590284735 +0.588379452 +0.586473196 +0.584565999 +0.582657889 +0.580748897 +0.578839052 +0.576928383 +0.575016922 +0.573104696 +0.571191736 +0.569278071 +0.567363731 +0.565448745 +0.563533143 +0.561616954 +0.559700208 +0.557782934 +0.555865161 +0.55394692 +0.552028238 +0.550109146 +0.548189672 +0.546269846 +0.544349698 +0.542429255 +0.540508548 +0.538587605 +0.536666456 +0.534745129 +0.532823654 +0.530902059 +0.528980373 +0.527058625 +0.525136844 +0.523215059 +0.521293298 +0.519371591 +0.517449965 +0.515528449 +0.513607073 +0.511685864 +0.50976485 +0.507844062 +0.505923526 +0.504003271 +0.502083325 +0.500163717 +0.498244475 +0.496325627 +0.494407201 +0.492489225 +0.490571727 +0.488654735 +0.486738277 +0.484822381 +0.482907074 +0.480992385 +0.479078341 +0.477164969 +0.475252298 +0.473340354 +0.471429166 +0.46951876 +0.467609163 +0.465700404 +0.46379251 +0.461885507 +0.459979423 +0.458074284 +0.456170119 +0.454266952 +0.452364813 +0.450463727 +0.44856372 +0.446664821 +0.444767055 +0.442870449 +0.440975029 +0.439080822 +0.437187854 +0.435296151 +0.433405741 +0.431516648 +0.429628898 +0.427742519 +0.425857536 +0.423973974 +0.422091859 +0.420211218 +0.418332076 +0.416454458 +0.41457839 +0.412703898 +0.410831006 +0.40895974 +0.407090126 +0.405222188 +0.403355952 +0.401491442 +0.399628683 +0.397767701 +0.39590852 +0.394051164 +0.392195659 +0.390342028 +0.388490297 +0.386640489 +0.384792629 +0.382946742 +0.38110285 +0.379260979 +0.377421152 +0.375583393 +0.373747726 +0.371914175 +0.370082763 +0.368253514 +0.366426451 +0.364601597 +0.362778977 +0.360958613 +0.359140527 +0.357324745 +0.355511287 +0.353700177 +0.351891438 +0.350085093 +0.348281164 +0.346479673 +0.344680644 +0.342884097 +0.341090057 +0.339298543 +0.33750958 +0.335723188 +0.33393939 +0.332158207 +0.330379661 +0.328603774 +0.326830566 +0.32506006 +0.323292277 +0.321527238 +0.319764964 +0.318005476 +0.316248795 +0.314494941 +0.312743936 +0.310995801 +0.309250555 +0.307508219 +0.305768814 +0.304032359 +0.302298875 +0.300568383 +0.298840901 +0.297116449 +0.295395048 +0.293676717 +0.291961476 +0.290249344 +0.28854034 +0.286834483 +0.285131794 +0.28343229 +0.28173599 +0.280042915 +0.278353081 +0.276666509 +0.274983216 +0.27330322 +0.271626541 +0.269953196 +0.268283204 +0.266616581 +0.264953348 +0.26329352 +0.261637116 +0.259984153 +0.258334649 +0.256688621 +0.255046087 +0.253407063 +0.251771567 +0.250139615 +0.248511225 +0.246886412 +0.245265195 +0.243647588 +0.242033609 +0.240423274 +0.238816598 +0.237213599 +0.235614292 +0.234018693 +0.232426817 +0.23083868 +0.229254299 +0.227673687 +0.22609686 +0.224523835 +0.222954624 +0.221389245 +0.219827711 +0.218270037 +0.216716237 +0.215166328 +0.213620321 +0.212078233 +0.210540077 +0.209005867 +0.207475618 +0.205949342 +0.204427054 +0.202908767 +0.201394495 +0.199884252 +0.198378049 +0.196875902 +0.195377822 +0.193883822 +0.192393916 +0.190908116 +0.189426435 +0.187948885 +0.186475478 +0.185006227 +0.183541144 +0.18208024 +0.180623529 +0.17917102 +0.177722727 +0.176278661 +0.174838833 +0.173403254 +0.171971936 +0.17054489 +0.169122126 +0.167703656 +0.16628949 +0.16487964 +0.163474114 +0.162072924 +0.160676081 +0.159283593 +0.157895472 +0.156511727 +0.155132369 +0.153757405 +0.152386847 +0.151020704 +0.149658985 +0.148301699 +0.146948856 +0.145600464 +0.144256532 +0.142917069 +0.141582084 +0.140251585 +0.138925581 +0.13760408 +0.136287089 +0.134974618 +0.133666674 +0.132363265 +0.131064399 +0.129770083 +0.128480324 +0.12719513 +0.125914509 +0.124638468 +0.123367012 +0.12210015 +0.120837889 +0.119580234 +0.118327192 +0.11707877 +0.115834975 +0.114595811 +0.113361286 +0.112131406 +0.110906175 +0.109685601 +0.108469688 +0.107258442 +0.106051869 +0.104849973 +0.103652761 +0.102460236 +0.101272404 +0.10008927 +0.0989108389 +0.0977371144 +0.0965681014 +0.0954038042 +0.0942442272 +0.0930893743 +0.0919392497 +0.0907938573 +0.0896532008 +0.0885172839 +0.0873861102 +0.0862596831 +0.0851380059 +0.084021082 +0.0829089143 +0.0818015059 +0.0806988597 +0.0796009785 +0.0785078648 +0.0774195212 +0.0763359503 +0.0752571542 +0.0741831353 +0.0731138955 +0.0720494369 +0.0709897614 +0.0699348708 +0.0688847666 +0.0678394504 +0.0667989237 +0.0657631878 +0.0647322439 +0.0637060931 +0.0626847363 +0.0616681745 +0.0606564085 +0.0596494388 +0.0586472661 +0.0576498908 +0.0566573133 +0.0556695337 +0.0546865522 +0.0537083688 +0.0527349834 +0.0517663958 +0.0508026057 +0.0498436127 +0.0488894162 +0.0479400157 +0.0469954103 +0.0460555993 +0.0451205816 +0.0441903564 +0.0432649222 +0.042344278 +0.0414284224 +0.0405173538 +0.0396110707 +0.0387095715 +0.0378128542 +0.0369209171 +0.0360337582 +0.0351513753 +0.0342737662 +0.0334009287 +0.0325328604 +0.0316695587 +0.030811021 +0.0299572447 +0.0291082269 +0.0282639647 +0.0274244551 +0.026589695 +0.0257596812 +0.0249344104 +0.0241138791 +0.0232980839 +0.0224870212 +0.0216806872 +0.0208790782 +0.0200821902 +0.0192900193 +0.0185025613 +0.0177198121 +0.0169417674 +0.0161684229 +0.0153997739 +0.014635816 +0.0138765444 +0.0131219545 +0.0123720414 +0.0116268 +0.0108862255 +0.0101503125 +0.00941905596 +0.00869245048 +0.00797049065 +0.00725317096 +0.00654048582 +0.00583242953 +0.00512899631 +0.00443018029 +0.0037359755 +0.00304637589 +0.00236137532 +0.00168096756 +0.00100514629 +0.000333905094 +0.000332762517 +0.000994863129 +0.00165240341 +0.00230539013 +0.00295383012 +0.00359773031 +0.00423709772 +0.00487193946 +0.0055022627 +0.00612807472 +0.00674938288 +0.0073661946 +0.00797851743 +0.00858635895 +0.00918972685 +0.00978862891 +0.010383073 +0.010973067 +0.0115586189 +0.0121397369 +0.0127164292 +0.0132887039 +0.0138565694 +0.0144200341 +0.0149791065 +0.0155337952 +0.0160841088 +0.0166300561 +0.0171716458 +0.0177088869 +0.0182417882 +0.0187703588 +0.0192946078 +0.0198145444 +0.0203301778 +0.0208415174 +0.0213485726 +0.0218513527 +0.0223498675 +0.0228441264 +0.0233341392 +0.0238199156 +0.0243014655 +0.0247787988 +0.0252519254 +0.0257208553 +0.0261855988 +0.0266461659 +0.0271025669 +0.0275548121 +0.0280029119 +0.0284468767 +0.0288867171 +0.0293224436 +0.0297540669 +0.0301815977 +0.0306050467 +0.0310244248 +0.0314397429 +0.031851012 +0.032258243 +0.0326614471 +0.0330606354 +0.0334558191 +0.0338470096 +0.034234218 +0.0346174559 +0.0349967347 +0.0353720658 +0.0357434609 +0.0361109316 +0.0364744895 +0.0368341464 +0.0371899142 +0.0375418045 +0.0378898295 +0.0382340009 +0.0385743309 +0.0389108315 +0.0392435149 +0.0395723931 +0.0398974785 +0.0402187834 +0.04053632 +0.0408501008 +0.0411601381 +0.0414664446 +0.0417690327 +0.042067915 +0.0423631041 +0.0426546128 +0.0429424537 +0.0432266396 +0.0435071835 +0.0437840981 +0.0440573963 +0.0443270912 +0.0445931957 +0.0448557228 +0.0451146858 +0.0453700977 +0.0456219717 +0.0458703211 +0.0461151591 +0.0463564989 +0.0465943541 +0.0468287379 +0.0470596638 +0.0472871453 +0.0475111958 +0.047731829 +0.0479490584 +0.0481628976 +0.0483733603 +0.0485804603 +0.0487842111 +0.0489846267 +0.0491817207 +0.0493755072 +0.0495659998 +0.0497532126 +0.0499371594 +0.0501178543 +0.0502953113 +0.0504695443 +0.0506405675 +0.050808395 +0.0509730408 +0.0511345192 +0.0512928443 +0.0514480304 +0.0516000917 +0.0517490425 +0.051894897 +0.0520376696 +0.0521773747 +0.0523140266 +0.0524476398 +0.0525782286 +0.0527058076 +0.0528303911 +0.0529519938 +0.05307063 +0.0531863145 +0.0532990617 +0.0534088862 +0.0535158026 +0.0536198256 +0.0537209699 +0.05381925 +0.0539146807 +0.0540072766 +0.0540970526 +0.0541840233 +0.0542682036 +0.0543496081 +0.0544282517 +0.0545041492 +0.0545773154 +0.0546477651 +0.0547155132 +0.0547805746 +0.0548429641 +0.0549026966 +0.0549597871 +0.0550142504 +0.0550661015 +0.0551153553 +0.0551620267 +0.0552061307 +0.0552476823 +0.0552866965 +0.0553231882 +0.0553571723 +0.055388664 +0.0554176782 +0.05544423 +0.0554683342 +0.0554900061 +0.0555092605 +0.0555261126 +0.0555405773 +0.0555526697 +0.0555624048 +0.0555697977 +0.0555748635 +0.0555776171 +0.0555780737 +0.0555762482 +0.0555721558 +0.0555658114 +0.0555572302 +0.0555464272 +0.0555334174 +0.0555182158 +0.0555008376 +0.0554812978 +0.0554596113 +0.0554357933 +0.0554098587 +0.0553818226 +0.0553517 +0.0553195059 +0.0552852554 +0.0552489633 +0.0552106448 +0.0551703148 +0.0551279883 +0.0550836803 +0.0550374056 +0.0549891794 +0.0549390164 +0.0548869318 +0.0548329402 +0.0547770568 +0.0547192964 +0.0546596738 +0.054598204 +0.0545349019 +0.0544697821 +0.0544028598 +0.0543341495 +0.0542636662 +0.0541914246 +0.0541174396 +0.0540417258 +0.0539642981 +0.0538851712 +0.0538043597 +0.0537218785 +0.0536377421 +0.0535519652 +0.0534645625 +0.0533755486 +0.0532849381 +0.0531927456 +0.0530989857 +0.0530036729 +0.0529068218 +0.0528084467 +0.0527085623 +0.052607183 +0.0525043232 +0.0523999974 +0.0522942199 +0.052187005 +0.0520783673 +0.0519683209 +0.0518568802 +0.0517440594 +0.0516298728 +0.0515143346 +0.051397459 +0.0512792601 +0.0511597522 +0.0510389492 +0.0509168654 +0.0507935148 +0.0506689113 +0.050543069 +0.0504160018 +0.0502877238 +0.0501582488 +0.0500275906 +0.0498957632 +0.0497627804 +0.0496286559 +0.0494934035 +0.0493570369 +0.0492195698 +0.049081016 +0.0489413889 +0.0488007022 +0.0486589695 +0.0485162042 +0.0483724199 +0.0482276301 +0.0480818481 +0.0479350873 +0.0477873611 +0.0476386828 +0.0474890656 +0.0473385229 +0.0471870678 +0.0470347135 +0.046881473 +0.0467273596 +0.0465723862 +0.0464165659 +0.0462599117 +0.0461024364 +0.045944153 +0.0457850743 +0.0456252131 +0.0454645823 +0.0453031945 +0.0451410625 +0.0449781989 +0.0448146163 +0.0446503273 +0.0444853444 +0.0443196801 +0.0441533468 +0.043986357 +0.043818723 +0.0436504571 +0.0434815715 +0.0433120786 +0.0431419904 +0.0429713192 +0.042800077 +0.0426282758 +0.0424559277 +0.0422830446 +0.0421096384 +0.041935721 +0.0417613042 +0.0415863998 +0.0414110195 +0.0412351749 +0.0410588778 +0.0408821396 +0.040704972 +0.0405273863 +0.0403493941 +0.0401710067 +0.0399922355 +0.0398130917 +0.0396335866 +0.0394537315 +0.0392735373 +0.0390930153 +0.0389121764 +0.0387310317 +0.0385495921 +0.0383678685 +0.0381858718 +0.0380036126 +0.0378211018 +0.0376383501 +0.037455368 +0.0372721662 +0.0370887552 +0.0369051454 +0.0367213474 +0.0365373714 +0.0363532278 +0.0361689269 +0.0359844789 +0.0357998938 +0.035615182 +0.0354303533 +0.0352454177 +0.0350603854 +0.034875266 +0.0346900696 +0.0345048057 +0.0343194843 +0.0341341149 +0.0339487071 +0.0337632706 +0.0335778148 +0.0333923492 +0.0332068831 +0.033021426 +0.0328359871 +0.0326505757 +0.0324652008 +0.0322798717 +0.0320945973 +0.0319093867 +0.0317242489 +0.0315391926 +0.0313542268 +0.0311693603 +0.0309846017 +0.0307999597 +0.0306154429 +0.0304310599 +0.0302468191 +0.030062729 +0.0298787979 +0.0296950342 +0.0295114461 +0.0293280419 +0.0291448296 +0.0289618173 +0.0287790131 +0.028596425 +0.0284140608 +0.0282319284 +0.0280500355 +0.02786839 +0.0276869995 +0.0275058715 +0.0273250137 +0.0271444336 +0.0269641386 +0.026784136 +0.0266044332 +0.0264250374 +0.0262459559 +0.0260671957 +0.025888764 +0.0257106678 +0.0255329141 +0.0253555097 +0.0251784614 +0.0250017762 +0.0248254606 +0.0246495214 +0.0244739651 +0.0242987984 +0.0241240276 +0.0239496593 +0.0237756997 +0.0236021552 +0.023429032 +0.0232563364 +0.0230840744 +0.022912252 +0.0227408754 +0.0225699504 +0.022399483 +0.0222294789 +0.0220599439 +0.0218908838 +0.0217223041 +0.0215542105 +0.0213866084 +0.0212195035 +0.0210529009 +0.0208868062 +0.0207212245 +0.0205561611 +0.0203916212 +0.0202276099 +0.0200641322 +0.0199011931 +0.0197387976 +0.0195769504 +0.0194156565 +0.0192549205 +0.0190947471 +0.018935141 +0.0187761068 +0.0186176488 +0.0184597717 +0.0183024798 +0.0181457774 +0.0179896688 +0.0178341581 +0.0176792496 +0.0175249474 +0.0173712555 +0.0172181778 +0.0170657182 +0.0169138808 +0.0167626691 +0.016612087 +0.0164621382 +0.0163128262 +0.0161641547 +0.0160161271 +0.0158687469 +0.0157220175 +0.0155759422 +0.0154305243 +0.0152857671 +0.0151416736 +0.0149982469 +0.0148554902 +0.0147134063 +0.0145719983 +0.0144312689 +0.0142912211 +0.0141518575 +0.0140131809 +0.0138751939 +0.013737899 +0.0136012989 +0.013465396 +0.0133301926 +0.0131956912 +0.0130618941 +0.0129288035 +0.0127964215 +0.0126647504 +0.0125337923 +0.012403549 +0.0122740227 +0.0121452151 +0.0120171282 +0.0118897639 +0.0117631237 +0.0116372094 +0.0115120227 +0.0113875651 +0.0112638382 +0.0111408434 +0.0110185822 +0.0108970559 +0.0107762659 +0.0106562134 +0.0105368995 +0.0104183255 +0.0103004925 +0.0101834015 +0.0100670535 +0.00995144942 +0.00983659019 +0.00972247662 +0.00960910951 +0.00949648959 +0.00938461754 +0.009273494 +0.00916311953 +0.00905349466 +0.00894461988 +0.00883649561 +0.00872912223 +0.00862250005 +0.00851662936 +0.00841151037 +0.00830714327 +0.00820352817 +0.00810066516 +0.00799855425 +0.00789719543 +0.00779658862 +0.00769673371 +0.00759763052 +0.00749927883 +0.00740167838 +0.00730482887 +0.00720872992 +0.00711338112 +0.00701878203 +0.00692493214 +0.0068318309 +0.00673947771 +0.00664787193 +0.00655701287 +0.0064668998 +0.00637753194 +0.00628890846 +0.00620102849 +0.00611389112 +0.00602749537 +0.00594184025 +0.00585692471 +0.00577274766 +0.00568930794 +0.00560660439 +0.00552463578 +0.00544340083 +0.00536289824 +0.00528312666 +0.00520408468 +0.00512577087 +0.00504818374 +0.00497132178 +0.00489518341 +0.00481976704 +0.00474507101 +0.00467109365 +0.00459783321 +0.00452528793 +0.00445345601 +0.0043823356 +0.0043119248 +0.00424222169 +0.0041732243 +0.00410493063 +0.00403733864 +0.00397044624 +0.00390425132 +0.0038387517 +0.00377394521 +0.00370982961 +0.00364640262 +0.00358366195 +0.00352160525 +0.00346023013 +0.00339953419 +0.00333951498 +0.00328017001 +0.00322149675 +0.00316349266 +0.00310615513 +0.00304948156 +0.00299346927 +0.00293811558 +0.00288341775 +0.00282937304 +0.00277597864 +0.00272323174 +0.00267112947 +0.00261966894 +0.00256884724 +0.00251866141 +0.00246910847 +0.00242018539 +0.00237188914 +0.00232421664 +0.00227716478 +0.00223073043 +0.00218491041 +0.00213970154 +0.00209510058 +0.00205110429 +0.00200770937 +0.00196491254 +0.00192271043 +0.0018810997 +0.00184007694 +0.00179963874 +0.00175978164 +0.00172050218 +0.00168179686 +0.00164366214 +0.00160609449 +0.00156909032 +0.00153264603 +0.001496758 +0.00146142258 +0.00142663608 +0.00139239482 +0.00135869507 +0.00132553309 +0.0012929051 +0.00126080731 +0.00122923593 +0.00119818709 +0.00116765696 +0.00113764165 +0.00110813726 +0.00107913988 +0.00105064555 +0.00102265032 +0.000995150203 +0.000968141203 +0.000941619297 +0.000915580444 +0.000890020586 +0.000864935645 +0.000840321525 +0.000816174114 +0.000792489279 +0.000769262873 +0.000746490729 +0.000724168666 +0.000702292483 +0.000680857968 +0.000659860888 +0.000639296997 +0.000619162034 +0.000599451722 +0.000580161769 +0.000561287871 +0.000542825708 +0.000524770946 +0.000507119238 +0.000489866224 +0.000473007532 +0.000456538775 +0.000440455557 +0.000424753467 +0.000409428083 +0.000394474974 +0.000379889695 +0.000365667792 +0.000351804799 +0.000338296241 +0.000325137633 +0.000312324481 +0.000299852279 +0.000287716515 +0.000275912667 +0.000264436206 +0.000253282591 +0.000242447278 +0.000231925713 +0.000221713335 +0.000211805575 +0.000202197861 +0.00019288561 +0.000183864235 +0.000175129145 +0.000166675742 +0.000158499421 +0.000150595575 +0.000142959591 +0.000135586852 +0.000128472737 +0.000121612621 +0.000115001876 +0.000108635872 +0.000102509973 +9.66195432e-05 +9.09599435e-05 +8.5526533e-05 +8.0314669e-05 +7.53197076e-05 +7.05370036e-05 +6.59619109e-05 +6.15897832e-05 +5.74159736e-05 +5.34358353e-05 +4.96447219e-05 +4.60379876e-05 +4.26109873e-05 +3.93590773e-05 +3.6277615e-05 +3.33619599e-05 +3.06074732e-05 +2.80095185e-05 +2.5563462e-05 +2.32646727e-05 +2.11085226e-05 +1.90903871e-05 +1.72056456e-05 +1.54496809e-05 +1.38178804e-05 +1.23056359e-05 +1.09083439e-05 +9.62140598e-06 +8.44022899e-06 +7.36022539e-06 +6.37681346e-06 +5.48541761e-06 +4.68146863e-06 +3.96040395e-06 +3.31766794e-06 +2.74871213e-06 +2.24899552e-06 +1.81398481e-06 +1.43915468e-06 +1.11998804e-06 +8.51976334e-07 +6.30619731e-07 +4.51427445e-07 +3.09917965e-07 +2.01619321e-07 +1.22069341e-07 +6.68159063e-08 +3.14172076e-08 +1.14419998e-08 +2.46985517e-09 +9.14157145e-11 + +shape_id 2 +num_samples 3000 +0.5 +0 +0 +747 +-0.5 +0 +0 +1497 +0.5 +0 +0 +747 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash 8804e18306cbe4f12886634b3ebaa0c9 diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/fid.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/fid.mat new file mode 100644 index 000000000..b0c39bdd7 Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/fid.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/fid.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/fid.seq new file mode 100644 index 000000000..05248cea4 --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/fid.seq @@ -0,0 +1,89 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name fid +RadiofrequencyRasterTime 1e-06 +TotalDuration 80.32 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] + 1 2000 1 0 0 0 0 0 + 2 500000 0 0 0 0 1 0 + 3 2000 1 0 0 0 0 0 + 4 500000 0 0 0 0 1 0 + 5 2000 1 0 0 0 0 0 + 6 500000 0 0 0 0 1 0 + 7 2000 1 0 0 0 0 0 + 8 500000 0 0 0 0 1 0 + 9 2000 1 0 0 0 0 0 +10 500000 0 0 0 0 1 0 +11 2000 1 0 0 0 0 0 +12 500000 0 0 0 0 1 0 +13 2000 1 0 0 0 0 0 +14 500000 0 0 0 0 1 0 +15 2000 1 0 0 0 0 0 +16 500000 0 0 0 0 1 0 +17 2000 1 0 0 0 0 0 +18 500000 0 0 0 0 1 0 +19 2000 1 0 0 0 0 0 +20 500000 0 0 0 0 1 0 +21 2000 1 0 0 0 0 0 +22 500000 0 0 0 0 1 0 +23 2000 1 0 0 0 0 0 +24 500000 0 0 0 0 1 0 +25 2000 1 0 0 0 0 0 +26 500000 0 0 0 0 1 0 +27 2000 1 0 0 0 0 0 +28 500000 0 0 0 0 1 0 +29 2000 1 0 0 0 0 0 +30 500000 0 0 0 0 1 0 +31 2000 1 0 0 0 0 0 +32 500000 0 0 0 0 1 0 + +# Format of RF events: +# id amplitude mag_id phase_id time_shape_id delay freq phase +# .. Hz .... .... .... us Hz rad +[RF] +1 2500 1 2 3 100 0 0 + +# Format of ADC events: +# id num dwell delay freq phase +# .. .. ns us Hz rad +[ADC] +1 2048 62500 20 0 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 2 +1 +1 + +shape_id 2 +num_samples 2 +0 +0 + +shape_id 3 +num_samples 2 +0 +100 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash bb01a1c792a78b853e1116c2fdfb6b27 diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-time-shaped.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-time-shaped.mat new file mode 100644 index 000000000..d89650dc0 Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-time-shaped.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-time-shaped.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-time-shaped.seq new file mode 100644 index 000000000..a84820c62 --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-time-shaped.seq @@ -0,0 +1,65 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name gr-time-shaped +RadiofrequencyRasterTime 1e-06 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] +1 18 0 1 0 0 0 0 +2 18 0 1 0 0 0 0 +3 18 0 1 0 0 0 0 + +# Format of arbitrary gradients: +# time_shape_id of 0 means default timing (stepping with grad_raster starting at 1/2 of grad_raster) +# id amplitude amp_shape_id time_shape_id delay +# .. Hz/m .. .. us +[GRADIENTS] +1 42576 1 2 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 10 +1 +0.766044443 +0.173648178 +-0.5 +-0.939692621 +-0.939692621 +-0.5 +0.173648178 +0.766044443 +1 + +shape_id 2 +num_samples 10 +0 +1 +2 +4 +7 +8 +10 +13 +16 +18 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash cfb0a878608b7accf36d3e19052538b8 diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-trapezoidal.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-trapezoidal.mat new file mode 100644 index 000000000..828a39b39 Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-trapezoidal.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-trapezoidal.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-trapezoidal.seq new file mode 100644 index 000000000..006fb588b --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-trapezoidal.seq @@ -0,0 +1,41 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name gr-trapezoidal +RadiofrequencyRasterTime 1e-06 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] +1 100 0 1 0 0 0 0 +2 100 0 1 0 0 0 0 +3 100 0 1 0 0 0 0 +4 100 0 1 0 0 0 0 +5 100 0 1 0 0 0 0 +6 100 0 1 0 0 0 0 +7 100 0 1 0 0 0 0 +8 100 0 1 0 0 0 0 +9 100 0 1 0 0 0 0 + +# Format of trapezoid gradients: +# id amplitude rise flat fall delay +# .. Hz/m us us us us +[TRAP] + 1 425760 60 880 60 0 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash 8b87c2b1caad8dcb8f25257b285e11ad diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-uniformly-shaped.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-uniformly-shaped.mat new file mode 100644 index 000000000..1e3565b4b Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-uniformly-shaped.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-uniformly-shaped.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-uniformly-shaped.seq new file mode 100644 index 000000000..b1f84b884 --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gr-uniformly-shaped.seq @@ -0,0 +1,52 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name gr-uniformly-shaped +RadiofrequencyRasterTime 1e-06 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] +1 10 0 1 0 0 0 0 +2 10 0 1 0 0 0 0 +3 10 0 1 0 0 0 0 + +# Format of arbitrary gradients: +# time_shape_id of 0 means default timing (stepping with grad_raster starting at 1/2 of grad_raster) +# id amplitude amp_shape_id time_shape_id delay +# .. Hz/m .. .. us +[GRADIENTS] +1 42576 1 0 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 10 +1 +0.766044443 +0.173648178 +-0.5 +-0.939692621 +-0.939692621 +-0.5 +0.173648178 +0.766044443 +1 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash 41e555c258d0f6056c9bbe178240a891 diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gre.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gre.mat new file mode 100644 index 000000000..42a0df890 Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gre.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/gre.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gre.seq new file mode 100644 index 000000000..6bcffa40c --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/gre.seq @@ -0,0 +1,4656 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +FOV 0.256 0.256 0.003 +GradientRasterTime 1e-05 +Name gre +RadiofrequencyRasterTime 1e-06 +TotalDuration 3.072 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] + 1 319 1 0 0 1 0 0 + 2 100 0 2 3 4 0 0 + 3 74 0 0 0 0 0 0 + 4 334 0 5 0 0 1 0 + 5 373 0 6 7 8 0 0 + 6 319 2 0 0 1 0 0 + 7 100 0 2 9 4 0 0 + 8 74 0 0 0 0 0 0 + 9 334 0 5 0 0 2 0 + 10 373 0 6 10 8 0 0 + 11 319 3 0 0 1 0 0 + 12 100 0 2 11 4 0 0 + 13 74 0 0 0 0 0 0 + 14 334 0 5 0 0 3 0 + 15 373 0 6 12 8 0 0 + 16 319 4 0 0 1 0 0 + 17 100 0 2 13 4 0 0 + 18 74 0 0 0 0 0 0 + 19 334 0 5 0 0 4 0 + 20 373 0 6 14 8 0 0 + 21 319 5 0 0 1 0 0 + 22 100 0 2 15 4 0 0 + 23 74 0 0 0 0 0 0 + 24 334 0 5 0 0 5 0 + 25 373 0 6 16 8 0 0 + 26 319 6 0 0 1 0 0 + 27 100 0 2 17 4 0 0 + 28 74 0 0 0 0 0 0 + 29 334 0 5 0 0 6 0 + 30 373 0 6 18 8 0 0 + 31 319 7 0 0 1 0 0 + 32 100 0 2 19 4 0 0 + 33 74 0 0 0 0 0 0 + 34 334 0 5 0 0 7 0 + 35 373 0 6 20 8 0 0 + 36 319 8 0 0 1 0 0 + 37 100 0 2 21 4 0 0 + 38 74 0 0 0 0 0 0 + 39 334 0 5 0 0 8 0 + 40 373 0 6 22 8 0 0 + 41 319 9 0 0 1 0 0 + 42 100 0 2 23 4 0 0 + 43 74 0 0 0 0 0 0 + 44 334 0 5 0 0 9 0 + 45 373 0 6 24 8 0 0 + 46 319 10 0 0 1 0 0 + 47 100 0 2 25 4 0 0 + 48 74 0 0 0 0 0 0 + 49 334 0 5 0 0 10 0 + 50 373 0 6 26 8 0 0 + 51 319 6 0 0 1 0 0 + 52 100 0 2 27 4 0 0 + 53 74 0 0 0 0 0 0 + 54 334 0 5 0 0 6 0 + 55 373 0 6 28 8 0 0 + 56 319 11 0 0 1 0 0 + 57 100 0 2 29 4 0 0 + 58 74 0 0 0 0 0 0 + 59 334 0 5 0 0 11 0 + 60 373 0 6 30 8 0 0 + 61 319 12 0 0 1 0 0 + 62 100 0 2 31 4 0 0 + 63 74 0 0 0 0 0 0 + 64 334 0 5 0 0 12 0 + 65 373 0 6 32 8 0 0 + 66 319 13 0 0 1 0 0 + 67 100 0 2 33 4 0 0 + 68 74 0 0 0 0 0 0 + 69 334 0 5 0 0 13 0 + 70 373 0 6 34 8 0 0 + 71 319 14 0 0 1 0 0 + 72 100 0 2 35 4 0 0 + 73 74 0 0 0 0 0 0 + 74 334 0 5 0 0 14 0 + 75 373 0 6 36 8 0 0 + 76 319 1 0 0 1 0 0 + 77 100 0 2 37 4 0 0 + 78 74 0 0 0 0 0 0 + 79 334 0 5 0 0 1 0 + 80 373 0 6 38 8 0 0 + 81 319 15 0 0 1 0 0 + 82 100 0 2 39 4 0 0 + 83 74 0 0 0 0 0 0 + 84 334 0 5 0 0 15 0 + 85 373 0 6 40 8 0 0 + 86 319 16 0 0 1 0 0 + 87 100 0 2 41 4 0 0 + 88 74 0 0 0 0 0 0 + 89 334 0 5 0 0 16 0 + 90 373 0 6 42 8 0 0 + 91 319 13 0 0 1 0 0 + 92 100 0 2 43 4 0 0 + 93 74 0 0 0 0 0 0 + 94 334 0 5 0 0 13 0 + 95 373 0 6 44 8 0 0 + 96 319 17 0 0 1 0 0 + 97 100 0 2 45 4 0 0 + 98 74 0 0 0 0 0 0 + 99 334 0 5 0 0 17 0 + 100 373 0 6 46 8 0 0 + 101 319 5 0 0 1 0 0 + 102 100 0 2 47 4 0 0 + 103 74 0 0 0 0 0 0 + 104 334 0 5 0 0 5 0 + 105 373 0 6 48 8 0 0 + 106 319 18 0 0 1 0 0 + 107 100 0 2 49 4 0 0 + 108 74 0 0 0 0 0 0 + 109 334 0 5 0 0 18 0 + 110 373 0 6 50 8 0 0 + 111 319 19 0 0 1 0 0 + 112 100 0 2 51 4 0 0 + 113 74 0 0 0 0 0 0 + 114 334 0 5 0 0 19 0 + 115 373 0 6 52 8 0 0 + 116 319 9 0 0 1 0 0 + 117 100 0 2 53 4 0 0 + 118 74 0 0 0 0 0 0 + 119 334 0 5 0 0 9 0 + 120 373 0 6 54 8 0 0 + 121 319 20 0 0 1 0 0 + 122 100 0 2 55 4 0 0 + 123 74 0 0 0 0 0 0 + 124 334 0 5 0 0 20 0 + 125 373 0 6 56 8 0 0 + 126 319 10 0 0 1 0 0 + 127 100 0 2 57 4 0 0 + 128 74 0 0 0 0 0 0 + 129 334 0 5 0 0 10 0 + 130 373 0 6 58 8 0 0 + 131 319 18 0 0 1 0 0 + 132 100 0 2 59 4 0 0 + 133 74 0 0 0 0 0 0 + 134 334 0 5 0 0 18 0 + 135 373 0 6 60 8 0 0 + 136 319 21 0 0 1 0 0 + 137 100 0 2 61 4 0 0 + 138 74 0 0 0 0 0 0 + 139 334 0 5 0 0 21 0 + 140 373 0 6 62 8 0 0 + 141 319 4 0 0 1 0 0 + 142 100 0 2 63 4 0 0 + 143 74 0 0 0 0 0 0 + 144 334 0 5 0 0 4 0 + 145 373 0 6 64 8 0 0 + 146 319 22 0 0 1 0 0 + 147 100 0 2 65 4 0 0 + 148 74 0 0 0 0 0 0 + 149 334 0 5 0 0 22 0 + 150 373 0 6 66 8 0 0 + 151 319 14 0 0 1 0 0 + 152 100 0 2 67 4 0 0 + 153 74 0 0 0 0 0 0 + 154 334 0 5 0 0 14 0 + 155 373 0 6 68 8 0 0 + 156 319 15 0 0 1 0 0 + 157 100 0 2 69 4 0 0 + 158 74 0 0 0 0 0 0 + 159 334 0 5 0 0 15 0 + 160 373 0 6 70 8 0 0 + 161 319 23 0 0 1 0 0 + 162 100 0 2 71 4 0 0 + 163 74 0 0 0 0 0 0 + 164 334 0 5 0 0 23 0 + 165 373 0 6 72 8 0 0 + 166 319 2 0 0 1 0 0 + 167 100 0 2 73 4 0 0 + 168 74 0 0 0 0 0 0 + 169 334 0 5 0 0 2 0 + 170 373 0 6 74 8 0 0 + 171 319 22 0 0 1 0 0 + 172 100 0 2 75 4 0 0 + 173 74 0 0 0 0 0 0 + 174 334 0 5 0 0 22 0 + 175 373 0 6 76 8 0 0 + 176 319 17 0 0 1 0 0 + 177 100 0 2 77 4 0 0 + 178 74 0 0 0 0 0 0 + 179 334 0 5 0 0 17 0 + 180 373 0 6 78 8 0 0 + 181 319 11 0 0 1 0 0 + 182 100 0 2 79 4 0 0 + 183 74 0 0 0 0 0 0 + 184 334 0 5 0 0 11 0 + 185 373 0 6 80 8 0 0 + 186 319 24 0 0 1 0 0 + 187 100 0 2 81 4 0 0 + 188 74 0 0 0 0 0 0 + 189 334 0 5 0 0 24 0 + 190 373 0 6 82 8 0 0 + 191 319 7 0 0 1 0 0 + 192 100 0 2 83 4 0 0 + 193 74 0 0 0 0 0 0 + 194 334 0 5 0 0 7 0 + 195 373 0 6 84 8 0 0 + 196 319 20 0 0 1 0 0 + 197 100 0 2 85 4 0 0 + 198 74 0 0 0 0 0 0 + 199 334 0 5 0 0 20 0 + 200 373 0 6 86 8 0 0 + 201 319 20 0 0 1 0 0 + 202 100 0 2 87 4 0 0 + 203 74 0 0 0 0 0 0 + 204 334 0 5 0 0 20 0 + 205 373 0 6 88 8 0 0 + 206 319 7 0 0 1 0 0 + 207 100 0 2 89 4 0 0 + 208 74 0 0 0 0 0 0 + 209 334 0 5 0 0 7 0 + 210 373 0 6 90 8 0 0 + 211 319 24 0 0 1 0 0 + 212 100 0 2 91 4 0 0 + 213 74 0 0 0 0 0 0 + 214 334 0 5 0 0 24 0 + 215 373 0 6 92 8 0 0 + 216 319 11 0 0 1 0 0 + 217 100 0 2 93 4 0 0 + 218 74 0 0 0 0 0 0 + 219 334 0 5 0 0 11 0 + 220 373 0 6 94 8 0 0 + 221 319 17 0 0 1 0 0 + 222 100 0 2 95 4 0 0 + 223 74 0 0 0 0 0 0 + 224 334 0 5 0 0 17 0 + 225 373 0 6 96 8 0 0 + 226 319 22 0 0 1 0 0 + 227 100 0 2 97 4 0 0 + 228 74 0 0 0 0 0 0 + 229 334 0 5 0 0 22 0 + 230 373 0 6 98 8 0 0 + 231 319 2 0 0 1 0 0 + 232 100 0 2 99 4 0 0 + 233 74 0 0 0 0 0 0 + 234 334 0 5 0 0 2 0 + 235 373 0 6 100 8 0 0 + 236 319 23 0 0 1 0 0 + 237 100 0 2 101 4 0 0 + 238 74 0 0 0 0 0 0 + 239 334 0 5 0 0 23 0 + 240 373 0 6 102 8 0 0 + 241 319 15 0 0 1 0 0 + 242 100 0 2 103 4 0 0 + 243 74 0 0 0 0 0 0 + 244 334 0 5 0 0 15 0 + 245 373 0 6 104 8 0 0 + 246 319 14 0 0 1 0 0 + 247 100 0 2 105 4 0 0 + 248 74 0 0 0 0 0 0 + 249 334 0 5 0 0 14 0 + 250 373 0 6 106 8 0 0 + 251 319 22 0 0 1 0 0 + 252 100 0 2 107 4 0 0 + 253 74 0 0 0 0 0 0 + 254 334 0 5 0 0 22 0 + 255 373 0 6 108 8 0 0 + 256 319 4 0 0 1 0 0 + 257 100 0 2 109 4 0 0 + 258 74 0 0 0 0 0 0 + 259 334 0 5 0 0 4 0 + 260 373 0 6 110 8 0 0 + 261 319 21 0 0 1 0 0 + 262 100 0 2 111 4 0 0 + 263 74 0 0 0 0 0 0 + 264 334 0 5 0 0 21 0 + 265 373 0 6 112 8 0 0 + 266 319 18 0 0 1 0 0 + 267 100 0 2 113 4 0 0 + 268 74 0 0 0 0 0 0 + 269 334 0 5 0 0 18 0 + 270 373 0 6 114 8 0 0 + 271 319 10 0 0 1 0 0 + 272 100 0 2 115 4 0 0 + 273 74 0 0 0 0 0 0 + 274 334 0 5 0 0 10 0 + 275 373 0 6 116 8 0 0 + 276 319 20 0 0 1 0 0 + 277 100 0 2 117 4 0 0 + 278 74 0 0 0 0 0 0 + 279 334 0 5 0 0 20 0 + 280 373 0 6 118 8 0 0 + 281 319 9 0 0 1 0 0 + 282 100 0 2 119 4 0 0 + 283 74 0 0 0 0 0 0 + 284 334 0 5 0 0 9 0 + 285 373 0 6 120 8 0 0 + 286 319 19 0 0 1 0 0 + 287 100 0 2 121 4 0 0 + 288 74 0 0 0 0 0 0 + 289 334 0 5 0 0 19 0 + 290 373 0 6 122 8 0 0 + 291 319 18 0 0 1 0 0 + 292 100 0 2 123 4 0 0 + 293 74 0 0 0 0 0 0 + 294 334 0 5 0 0 18 0 + 295 373 0 6 124 8 0 0 + 296 319 5 0 0 1 0 0 + 297 100 0 2 125 4 0 0 + 298 74 0 0 0 0 0 0 + 299 334 0 5 0 0 5 0 + 300 373 0 6 126 8 0 0 + 301 319 17 0 0 1 0 0 + 302 100 0 2 127 4 0 0 + 303 74 0 0 0 0 0 0 + 304 334 0 5 0 0 17 0 + 305 373 0 6 128 8 0 0 + 306 319 13 0 0 1 0 0 + 307 100 0 2 129 4 0 0 + 308 74 0 0 0 0 0 0 + 309 334 0 5 0 0 13 0 + 310 373 0 6 130 8 0 0 + 311 319 16 0 0 1 0 0 + 312 100 0 2 131 4 0 0 + 313 74 0 0 0 0 0 0 + 314 334 0 5 0 0 16 0 + 315 373 0 6 132 8 0 0 + 316 319 15 0 0 1 0 0 + 317 100 0 2 133 4 0 0 + 318 74 0 0 0 0 0 0 + 319 334 0 5 0 0 15 0 + 320 373 0 6 134 8 0 0 + 321 319 1 0 0 1 0 0 + 322 100 0 2 135 4 0 0 + 323 74 0 0 0 0 0 0 + 324 334 0 5 0 0 1 0 + 325 373 0 6 136 8 0 0 + 326 319 14 0 0 1 0 0 + 327 100 0 2 137 4 0 0 + 328 74 0 0 0 0 0 0 + 329 334 0 5 0 0 14 0 + 330 373 0 6 138 8 0 0 + 331 319 13 0 0 1 0 0 + 332 100 0 2 139 4 0 0 + 333 74 0 0 0 0 0 0 + 334 334 0 5 0 0 13 0 + 335 373 0 6 140 8 0 0 + 336 319 12 0 0 1 0 0 + 337 100 0 2 141 4 0 0 + 338 74 0 0 0 0 0 0 + 339 334 0 5 0 0 12 0 + 340 373 0 6 142 8 0 0 + 341 319 11 0 0 1 0 0 + 342 100 0 2 143 4 0 0 + 343 74 0 0 0 0 0 0 + 344 334 0 5 0 0 11 0 + 345 373 0 6 144 8 0 0 + 346 319 6 0 0 1 0 0 + 347 100 0 2 145 4 0 0 + 348 74 0 0 0 0 0 0 + 349 334 0 5 0 0 6 0 + 350 373 0 6 146 8 0 0 + 351 319 10 0 0 1 0 0 + 352 100 0 2 147 4 0 0 + 353 74 0 0 0 0 0 0 + 354 334 0 5 0 0 10 0 + 355 373 0 6 148 8 0 0 + 356 319 9 0 0 1 0 0 + 357 100 0 2 149 4 0 0 + 358 74 0 0 0 0 0 0 + 359 334 0 5 0 0 9 0 + 360 373 0 6 150 8 0 0 + 361 319 8 0 0 1 0 0 + 362 100 0 2 151 4 0 0 + 363 74 0 0 0 0 0 0 + 364 334 0 5 0 0 8 0 + 365 373 0 6 152 8 0 0 + 366 319 7 0 0 1 0 0 + 367 100 0 2 153 4 0 0 + 368 74 0 0 0 0 0 0 + 369 334 0 5 0 0 7 0 + 370 373 0 6 154 8 0 0 + 371 319 6 0 0 1 0 0 + 372 100 0 2 155 4 0 0 + 373 74 0 0 0 0 0 0 + 374 334 0 5 0 0 6 0 + 375 373 0 6 156 8 0 0 + 376 319 5 0 0 1 0 0 + 377 100 0 2 157 4 0 0 + 378 74 0 0 0 0 0 0 + 379 334 0 5 0 0 5 0 + 380 373 0 6 158 8 0 0 + 381 319 4 0 0 1 0 0 + 382 100 0 2 159 4 0 0 + 383 74 0 0 0 0 0 0 + 384 334 0 5 0 0 4 0 + 385 373 0 6 160 8 0 0 + 386 319 3 0 0 1 0 0 + 387 100 0 2 161 4 0 0 + 388 74 0 0 0 0 0 0 + 389 334 0 5 0 0 3 0 + 390 373 0 6 162 8 0 0 + 391 319 2 0 0 1 0 0 + 392 100 0 2 163 4 0 0 + 393 74 0 0 0 0 0 0 + 394 334 0 5 0 0 2 0 + 395 373 0 6 164 8 0 0 + 396 319 1 0 0 1 0 0 + 397 100 0 2 165 4 0 0 + 398 74 0 0 0 0 0 0 + 399 334 0 5 0 0 1 0 + 400 373 0 6 166 8 0 0 + 401 319 1 0 0 1 0 0 + 402 100 0 2 167 4 0 0 + 403 74 0 0 0 0 0 0 + 404 334 0 5 0 0 1 0 + 405 373 0 6 168 8 0 0 + 406 319 2 0 0 1 0 0 + 407 100 0 2 169 4 0 0 + 408 74 0 0 0 0 0 0 + 409 334 0 5 0 0 2 0 + 410 373 0 6 170 8 0 0 + 411 319 3 0 0 1 0 0 + 412 100 0 2 171 4 0 0 + 413 74 0 0 0 0 0 0 + 414 334 0 5 0 0 3 0 + 415 373 0 6 172 8 0 0 + 416 319 4 0 0 1 0 0 + 417 100 0 2 173 4 0 0 + 418 74 0 0 0 0 0 0 + 419 334 0 5 0 0 4 0 + 420 373 0 6 174 8 0 0 + 421 319 5 0 0 1 0 0 + 422 100 0 2 175 4 0 0 + 423 74 0 0 0 0 0 0 + 424 334 0 5 0 0 5 0 + 425 373 0 6 176 8 0 0 + 426 319 6 0 0 1 0 0 + 427 100 0 2 177 4 0 0 + 428 74 0 0 0 0 0 0 + 429 334 0 5 0 0 6 0 + 430 373 0 6 178 8 0 0 + 431 319 7 0 0 1 0 0 + 432 100 0 2 179 4 0 0 + 433 74 0 0 0 0 0 0 + 434 334 0 5 0 0 7 0 + 435 373 0 6 180 8 0 0 + 436 319 8 0 0 1 0 0 + 437 100 0 2 181 4 0 0 + 438 74 0 0 0 0 0 0 + 439 334 0 5 0 0 8 0 + 440 373 0 6 182 8 0 0 + 441 319 9 0 0 1 0 0 + 442 100 0 2 183 4 0 0 + 443 74 0 0 0 0 0 0 + 444 334 0 5 0 0 9 0 + 445 373 0 6 184 8 0 0 + 446 319 10 0 0 1 0 0 + 447 100 0 2 185 4 0 0 + 448 74 0 0 0 0 0 0 + 449 334 0 5 0 0 10 0 + 450 373 0 6 186 8 0 0 + 451 319 6 0 0 1 0 0 + 452 100 0 2 187 4 0 0 + 453 74 0 0 0 0 0 0 + 454 334 0 5 0 0 6 0 + 455 373 0 6 188 8 0 0 + 456 319 11 0 0 1 0 0 + 457 100 0 2 189 4 0 0 + 458 74 0 0 0 0 0 0 + 459 334 0 5 0 0 11 0 + 460 373 0 6 190 8 0 0 + 461 319 12 0 0 1 0 0 + 462 100 0 2 191 4 0 0 + 463 74 0 0 0 0 0 0 + 464 334 0 5 0 0 12 0 + 465 373 0 6 192 8 0 0 + 466 319 13 0 0 1 0 0 + 467 100 0 2 193 4 0 0 + 468 74 0 0 0 0 0 0 + 469 334 0 5 0 0 13 0 + 470 373 0 6 194 8 0 0 + 471 319 14 0 0 1 0 0 + 472 100 0 2 195 4 0 0 + 473 74 0 0 0 0 0 0 + 474 334 0 5 0 0 14 0 + 475 373 0 6 196 8 0 0 + 476 319 1 0 0 1 0 0 + 477 100 0 2 197 4 0 0 + 478 74 0 0 0 0 0 0 + 479 334 0 5 0 0 1 0 + 480 373 0 6 198 8 0 0 + 481 319 15 0 0 1 0 0 + 482 100 0 2 199 4 0 0 + 483 74 0 0 0 0 0 0 + 484 334 0 5 0 0 15 0 + 485 373 0 6 200 8 0 0 + 486 319 16 0 0 1 0 0 + 487 100 0 2 201 4 0 0 + 488 74 0 0 0 0 0 0 + 489 334 0 5 0 0 16 0 + 490 373 0 6 202 8 0 0 + 491 319 13 0 0 1 0 0 + 492 100 0 2 203 4 0 0 + 493 74 0 0 0 0 0 0 + 494 334 0 5 0 0 13 0 + 495 373 0 6 204 8 0 0 + 496 319 17 0 0 1 0 0 + 497 100 0 2 205 4 0 0 + 498 74 0 0 0 0 0 0 + 499 334 0 5 0 0 17 0 + 500 373 0 6 206 8 0 0 + 501 319 5 0 0 1 0 0 + 502 100 0 2 207 4 0 0 + 503 74 0 0 0 0 0 0 + 504 334 0 5 0 0 5 0 + 505 373 0 6 208 8 0 0 + 506 319 18 0 0 1 0 0 + 507 100 0 2 209 4 0 0 + 508 74 0 0 0 0 0 0 + 509 334 0 5 0 0 18 0 + 510 373 0 6 210 8 0 0 + 511 319 19 0 0 1 0 0 + 512 100 0 2 211 4 0 0 + 513 74 0 0 0 0 0 0 + 514 334 0 5 0 0 19 0 + 515 373 0 6 212 8 0 0 + 516 319 9 0 0 1 0 0 + 517 100 0 2 213 4 0 0 + 518 74 0 0 0 0 0 0 + 519 334 0 5 0 0 9 0 + 520 373 0 6 214 8 0 0 + 521 319 20 0 0 1 0 0 + 522 100 0 2 215 4 0 0 + 523 74 0 0 0 0 0 0 + 524 334 0 5 0 0 20 0 + 525 373 0 6 216 8 0 0 + 526 319 10 0 0 1 0 0 + 527 100 0 2 217 4 0 0 + 528 74 0 0 0 0 0 0 + 529 334 0 5 0 0 10 0 + 530 373 0 6 218 8 0 0 + 531 319 18 0 0 1 0 0 + 532 100 0 2 219 4 0 0 + 533 74 0 0 0 0 0 0 + 534 334 0 5 0 0 18 0 + 535 373 0 6 220 8 0 0 + 536 319 21 0 0 1 0 0 + 537 100 0 2 221 4 0 0 + 538 74 0 0 0 0 0 0 + 539 334 0 5 0 0 21 0 + 540 373 0 6 222 8 0 0 + 541 319 4 0 0 1 0 0 + 542 100 0 2 223 4 0 0 + 543 74 0 0 0 0 0 0 + 544 334 0 5 0 0 4 0 + 545 373 0 6 224 8 0 0 + 546 319 22 0 0 1 0 0 + 547 100 0 2 225 4 0 0 + 548 74 0 0 0 0 0 0 + 549 334 0 5 0 0 22 0 + 550 373 0 6 226 8 0 0 + 551 319 14 0 0 1 0 0 + 552 100 0 2 227 4 0 0 + 553 74 0 0 0 0 0 0 + 554 334 0 5 0 0 14 0 + 555 373 0 6 228 8 0 0 + 556 319 15 0 0 1 0 0 + 557 100 0 2 229 4 0 0 + 558 74 0 0 0 0 0 0 + 559 334 0 5 0 0 15 0 + 560 373 0 6 230 8 0 0 + 561 319 23 0 0 1 0 0 + 562 100 0 2 231 4 0 0 + 563 74 0 0 0 0 0 0 + 564 334 0 5 0 0 23 0 + 565 373 0 6 232 8 0 0 + 566 319 2 0 0 1 0 0 + 567 100 0 2 233 4 0 0 + 568 74 0 0 0 0 0 0 + 569 334 0 5 0 0 2 0 + 570 373 0 6 234 8 0 0 + 571 319 22 0 0 1 0 0 + 572 100 0 2 235 4 0 0 + 573 74 0 0 0 0 0 0 + 574 334 0 5 0 0 22 0 + 575 373 0 6 236 8 0 0 + 576 319 17 0 0 1 0 0 + 577 100 0 2 237 4 0 0 + 578 74 0 0 0 0 0 0 + 579 334 0 5 0 0 17 0 + 580 373 0 6 238 8 0 0 + 581 319 11 0 0 1 0 0 + 582 100 0 2 239 4 0 0 + 583 74 0 0 0 0 0 0 + 584 334 0 5 0 0 11 0 + 585 373 0 6 240 8 0 0 + 586 319 24 0 0 1 0 0 + 587 100 0 2 241 4 0 0 + 588 74 0 0 0 0 0 0 + 589 334 0 5 0 0 24 0 + 590 373 0 6 242 8 0 0 + 591 319 7 0 0 1 0 0 + 592 100 0 2 243 4 0 0 + 593 74 0 0 0 0 0 0 + 594 334 0 5 0 0 7 0 + 595 373 0 6 244 8 0 0 + 596 319 20 0 0 1 0 0 + 597 100 0 2 245 4 0 0 + 598 74 0 0 0 0 0 0 + 599 334 0 5 0 0 20 0 + 600 373 0 6 246 8 0 0 + 601 319 20 0 0 1 0 0 + 602 100 0 2 247 4 0 0 + 603 74 0 0 0 0 0 0 + 604 334 0 5 0 0 20 0 + 605 373 0 6 248 8 0 0 + 606 319 7 0 0 1 0 0 + 607 100 0 2 249 4 0 0 + 608 74 0 0 0 0 0 0 + 609 334 0 5 0 0 7 0 + 610 373 0 6 250 8 0 0 + 611 319 24 0 0 1 0 0 + 612 100 0 2 251 4 0 0 + 613 74 0 0 0 0 0 0 + 614 334 0 5 0 0 24 0 + 615 373 0 6 252 8 0 0 + 616 319 11 0 0 1 0 0 + 617 100 0 2 253 4 0 0 + 618 74 0 0 0 0 0 0 + 619 334 0 5 0 0 11 0 + 620 373 0 6 254 8 0 0 + 621 319 17 0 0 1 0 0 + 622 100 0 2 255 4 0 0 + 623 74 0 0 0 0 0 0 + 624 334 0 5 0 0 17 0 + 625 373 0 6 256 8 0 0 + 626 319 22 0 0 1 0 0 + 627 100 0 2 257 4 0 0 + 628 74 0 0 0 0 0 0 + 629 334 0 5 0 0 22 0 + 630 373 0 6 258 8 0 0 + 631 319 2 0 0 1 0 0 + 632 100 0 2 259 4 0 0 + 633 74 0 0 0 0 0 0 + 634 334 0 5 0 0 2 0 + 635 373 0 6 260 8 0 0 + 636 319 23 0 0 1 0 0 + 637 100 0 2 261 4 0 0 + 638 74 0 0 0 0 0 0 + 639 334 0 5 0 0 23 0 + 640 373 0 6 262 8 0 0 + 641 319 15 0 0 1 0 0 + 642 100 0 2 263 4 0 0 + 643 74 0 0 0 0 0 0 + 644 334 0 5 0 0 15 0 + 645 373 0 6 264 8 0 0 + 646 319 14 0 0 1 0 0 + 647 100 0 2 262 4 0 0 + 648 74 0 0 0 0 0 0 + 649 334 0 5 0 0 14 0 + 650 373 0 6 261 8 0 0 + 651 319 22 0 0 1 0 0 + 652 100 0 2 260 4 0 0 + 653 74 0 0 0 0 0 0 + 654 334 0 5 0 0 22 0 + 655 373 0 6 259 8 0 0 + 656 319 4 0 0 1 0 0 + 657 100 0 2 258 4 0 0 + 658 74 0 0 0 0 0 0 + 659 334 0 5 0 0 4 0 + 660 373 0 6 257 8 0 0 + 661 319 21 0 0 1 0 0 + 662 100 0 2 256 4 0 0 + 663 74 0 0 0 0 0 0 + 664 334 0 5 0 0 21 0 + 665 373 0 6 255 8 0 0 + 666 319 18 0 0 1 0 0 + 667 100 0 2 254 4 0 0 + 668 74 0 0 0 0 0 0 + 669 334 0 5 0 0 18 0 + 670 373 0 6 253 8 0 0 + 671 319 10 0 0 1 0 0 + 672 100 0 2 252 4 0 0 + 673 74 0 0 0 0 0 0 + 674 334 0 5 0 0 10 0 + 675 373 0 6 251 8 0 0 + 676 319 20 0 0 1 0 0 + 677 100 0 2 250 4 0 0 + 678 74 0 0 0 0 0 0 + 679 334 0 5 0 0 20 0 + 680 373 0 6 249 8 0 0 + 681 319 9 0 0 1 0 0 + 682 100 0 2 248 4 0 0 + 683 74 0 0 0 0 0 0 + 684 334 0 5 0 0 9 0 + 685 373 0 6 247 8 0 0 + 686 319 19 0 0 1 0 0 + 687 100 0 2 246 4 0 0 + 688 74 0 0 0 0 0 0 + 689 334 0 5 0 0 19 0 + 690 373 0 6 245 8 0 0 + 691 319 18 0 0 1 0 0 + 692 100 0 2 244 4 0 0 + 693 74 0 0 0 0 0 0 + 694 334 0 5 0 0 18 0 + 695 373 0 6 243 8 0 0 + 696 319 5 0 0 1 0 0 + 697 100 0 2 242 4 0 0 + 698 74 0 0 0 0 0 0 + 699 334 0 5 0 0 5 0 + 700 373 0 6 241 8 0 0 + 701 319 17 0 0 1 0 0 + 702 100 0 2 240 4 0 0 + 703 74 0 0 0 0 0 0 + 704 334 0 5 0 0 17 0 + 705 373 0 6 239 8 0 0 + 706 319 13 0 0 1 0 0 + 707 100 0 2 238 4 0 0 + 708 74 0 0 0 0 0 0 + 709 334 0 5 0 0 13 0 + 710 373 0 6 237 8 0 0 + 711 319 16 0 0 1 0 0 + 712 100 0 2 236 4 0 0 + 713 74 0 0 0 0 0 0 + 714 334 0 5 0 0 16 0 + 715 373 0 6 235 8 0 0 + 716 319 15 0 0 1 0 0 + 717 100 0 2 234 4 0 0 + 718 74 0 0 0 0 0 0 + 719 334 0 5 0 0 15 0 + 720 373 0 6 233 8 0 0 + 721 319 1 0 0 1 0 0 + 722 100 0 2 232 4 0 0 + 723 74 0 0 0 0 0 0 + 724 334 0 5 0 0 1 0 + 725 373 0 6 231 8 0 0 + 726 319 14 0 0 1 0 0 + 727 100 0 2 230 4 0 0 + 728 74 0 0 0 0 0 0 + 729 334 0 5 0 0 14 0 + 730 373 0 6 229 8 0 0 + 731 319 13 0 0 1 0 0 + 732 100 0 2 228 4 0 0 + 733 74 0 0 0 0 0 0 + 734 334 0 5 0 0 13 0 + 735 373 0 6 227 8 0 0 + 736 319 12 0 0 1 0 0 + 737 100 0 2 226 4 0 0 + 738 74 0 0 0 0 0 0 + 739 334 0 5 0 0 12 0 + 740 373 0 6 225 8 0 0 + 741 319 11 0 0 1 0 0 + 742 100 0 2 224 4 0 0 + 743 74 0 0 0 0 0 0 + 744 334 0 5 0 0 11 0 + 745 373 0 6 223 8 0 0 + 746 319 6 0 0 1 0 0 + 747 100 0 2 222 4 0 0 + 748 74 0 0 0 0 0 0 + 749 334 0 5 0 0 6 0 + 750 373 0 6 221 8 0 0 + 751 319 10 0 0 1 0 0 + 752 100 0 2 220 4 0 0 + 753 74 0 0 0 0 0 0 + 754 334 0 5 0 0 10 0 + 755 373 0 6 219 8 0 0 + 756 319 9 0 0 1 0 0 + 757 100 0 2 218 4 0 0 + 758 74 0 0 0 0 0 0 + 759 334 0 5 0 0 9 0 + 760 373 0 6 217 8 0 0 + 761 319 8 0 0 1 0 0 + 762 100 0 2 216 4 0 0 + 763 74 0 0 0 0 0 0 + 764 334 0 5 0 0 8 0 + 765 373 0 6 215 8 0 0 + 766 319 7 0 0 1 0 0 + 767 100 0 2 214 4 0 0 + 768 74 0 0 0 0 0 0 + 769 334 0 5 0 0 7 0 + 770 373 0 6 213 8 0 0 + 771 319 6 0 0 1 0 0 + 772 100 0 2 212 4 0 0 + 773 74 0 0 0 0 0 0 + 774 334 0 5 0 0 6 0 + 775 373 0 6 211 8 0 0 + 776 319 5 0 0 1 0 0 + 777 100 0 2 210 4 0 0 + 778 74 0 0 0 0 0 0 + 779 334 0 5 0 0 5 0 + 780 373 0 6 209 8 0 0 + 781 319 4 0 0 1 0 0 + 782 100 0 2 208 4 0 0 + 783 74 0 0 0 0 0 0 + 784 334 0 5 0 0 4 0 + 785 373 0 6 207 8 0 0 + 786 319 3 0 0 1 0 0 + 787 100 0 2 206 4 0 0 + 788 74 0 0 0 0 0 0 + 789 334 0 5 0 0 3 0 + 790 373 0 6 205 8 0 0 + 791 319 2 0 0 1 0 0 + 792 100 0 2 204 4 0 0 + 793 74 0 0 0 0 0 0 + 794 334 0 5 0 0 2 0 + 795 373 0 6 203 8 0 0 + 796 319 1 0 0 1 0 0 + 797 100 0 2 202 4 0 0 + 798 74 0 0 0 0 0 0 + 799 334 0 5 0 0 1 0 + 800 373 0 6 201 8 0 0 + 801 319 1 0 0 1 0 0 + 802 100 0 2 200 4 0 0 + 803 74 0 0 0 0 0 0 + 804 334 0 5 0 0 1 0 + 805 373 0 6 199 8 0 0 + 806 319 2 0 0 1 0 0 + 807 100 0 2 198 4 0 0 + 808 74 0 0 0 0 0 0 + 809 334 0 5 0 0 2 0 + 810 373 0 6 197 8 0 0 + 811 319 3 0 0 1 0 0 + 812 100 0 2 196 4 0 0 + 813 74 0 0 0 0 0 0 + 814 334 0 5 0 0 3 0 + 815 373 0 6 195 8 0 0 + 816 319 4 0 0 1 0 0 + 817 100 0 2 194 4 0 0 + 818 74 0 0 0 0 0 0 + 819 334 0 5 0 0 4 0 + 820 373 0 6 193 8 0 0 + 821 319 5 0 0 1 0 0 + 822 100 0 2 192 4 0 0 + 823 74 0 0 0 0 0 0 + 824 334 0 5 0 0 5 0 + 825 373 0 6 191 8 0 0 + 826 319 6 0 0 1 0 0 + 827 100 0 2 190 4 0 0 + 828 74 0 0 0 0 0 0 + 829 334 0 5 0 0 6 0 + 830 373 0 6 189 8 0 0 + 831 319 7 0 0 1 0 0 + 832 100 0 2 188 4 0 0 + 833 74 0 0 0 0 0 0 + 834 334 0 5 0 0 7 0 + 835 373 0 6 187 8 0 0 + 836 319 8 0 0 1 0 0 + 837 100 0 2 186 4 0 0 + 838 74 0 0 0 0 0 0 + 839 334 0 5 0 0 8 0 + 840 373 0 6 185 8 0 0 + 841 319 9 0 0 1 0 0 + 842 100 0 2 184 4 0 0 + 843 74 0 0 0 0 0 0 + 844 334 0 5 0 0 9 0 + 845 373 0 6 183 8 0 0 + 846 319 10 0 0 1 0 0 + 847 100 0 2 182 4 0 0 + 848 74 0 0 0 0 0 0 + 849 334 0 5 0 0 10 0 + 850 373 0 6 181 8 0 0 + 851 319 6 0 0 1 0 0 + 852 100 0 2 180 4 0 0 + 853 74 0 0 0 0 0 0 + 854 334 0 5 0 0 6 0 + 855 373 0 6 179 8 0 0 + 856 319 11 0 0 1 0 0 + 857 100 0 2 178 4 0 0 + 858 74 0 0 0 0 0 0 + 859 334 0 5 0 0 11 0 + 860 373 0 6 177 8 0 0 + 861 319 12 0 0 1 0 0 + 862 100 0 2 176 4 0 0 + 863 74 0 0 0 0 0 0 + 864 334 0 5 0 0 12 0 + 865 373 0 6 175 8 0 0 + 866 319 13 0 0 1 0 0 + 867 100 0 2 174 4 0 0 + 868 74 0 0 0 0 0 0 + 869 334 0 5 0 0 13 0 + 870 373 0 6 173 8 0 0 + 871 319 14 0 0 1 0 0 + 872 100 0 2 172 4 0 0 + 873 74 0 0 0 0 0 0 + 874 334 0 5 0 0 14 0 + 875 373 0 6 171 8 0 0 + 876 319 1 0 0 1 0 0 + 877 100 0 2 170 4 0 0 + 878 74 0 0 0 0 0 0 + 879 334 0 5 0 0 1 0 + 880 373 0 6 169 8 0 0 + 881 319 15 0 0 1 0 0 + 882 100 0 2 168 4 0 0 + 883 74 0 0 0 0 0 0 + 884 334 0 5 0 0 15 0 + 885 373 0 6 167 8 0 0 + 886 319 16 0 0 1 0 0 + 887 100 0 2 166 4 0 0 + 888 74 0 0 0 0 0 0 + 889 334 0 5 0 0 16 0 + 890 373 0 6 165 8 0 0 + 891 319 13 0 0 1 0 0 + 892 100 0 2 164 4 0 0 + 893 74 0 0 0 0 0 0 + 894 334 0 5 0 0 13 0 + 895 373 0 6 163 8 0 0 + 896 319 17 0 0 1 0 0 + 897 100 0 2 162 4 0 0 + 898 74 0 0 0 0 0 0 + 899 334 0 5 0 0 17 0 + 900 373 0 6 161 8 0 0 + 901 319 5 0 0 1 0 0 + 902 100 0 2 160 4 0 0 + 903 74 0 0 0 0 0 0 + 904 334 0 5 0 0 5 0 + 905 373 0 6 159 8 0 0 + 906 319 18 0 0 1 0 0 + 907 100 0 2 158 4 0 0 + 908 74 0 0 0 0 0 0 + 909 334 0 5 0 0 18 0 + 910 373 0 6 157 8 0 0 + 911 319 19 0 0 1 0 0 + 912 100 0 2 156 4 0 0 + 913 74 0 0 0 0 0 0 + 914 334 0 5 0 0 19 0 + 915 373 0 6 155 8 0 0 + 916 319 9 0 0 1 0 0 + 917 100 0 2 154 4 0 0 + 918 74 0 0 0 0 0 0 + 919 334 0 5 0 0 9 0 + 920 373 0 6 153 8 0 0 + 921 319 20 0 0 1 0 0 + 922 100 0 2 152 4 0 0 + 923 74 0 0 0 0 0 0 + 924 334 0 5 0 0 20 0 + 925 373 0 6 151 8 0 0 + 926 319 10 0 0 1 0 0 + 927 100 0 2 150 4 0 0 + 928 74 0 0 0 0 0 0 + 929 334 0 5 0 0 10 0 + 930 373 0 6 149 8 0 0 + 931 319 18 0 0 1 0 0 + 932 100 0 2 148 4 0 0 + 933 74 0 0 0 0 0 0 + 934 334 0 5 0 0 18 0 + 935 373 0 6 147 8 0 0 + 936 319 21 0 0 1 0 0 + 937 100 0 2 146 4 0 0 + 938 74 0 0 0 0 0 0 + 939 334 0 5 0 0 21 0 + 940 373 0 6 145 8 0 0 + 941 319 4 0 0 1 0 0 + 942 100 0 2 144 4 0 0 + 943 74 0 0 0 0 0 0 + 944 334 0 5 0 0 4 0 + 945 373 0 6 143 8 0 0 + 946 319 22 0 0 1 0 0 + 947 100 0 2 142 4 0 0 + 948 74 0 0 0 0 0 0 + 949 334 0 5 0 0 22 0 + 950 373 0 6 141 8 0 0 + 951 319 14 0 0 1 0 0 + 952 100 0 2 140 4 0 0 + 953 74 0 0 0 0 0 0 + 954 334 0 5 0 0 14 0 + 955 373 0 6 139 8 0 0 + 956 319 15 0 0 1 0 0 + 957 100 0 2 138 4 0 0 + 958 74 0 0 0 0 0 0 + 959 334 0 5 0 0 15 0 + 960 373 0 6 137 8 0 0 + 961 319 23 0 0 1 0 0 + 962 100 0 2 136 4 0 0 + 963 74 0 0 0 0 0 0 + 964 334 0 5 0 0 23 0 + 965 373 0 6 135 8 0 0 + 966 319 2 0 0 1 0 0 + 967 100 0 2 134 4 0 0 + 968 74 0 0 0 0 0 0 + 969 334 0 5 0 0 2 0 + 970 373 0 6 133 8 0 0 + 971 319 22 0 0 1 0 0 + 972 100 0 2 132 4 0 0 + 973 74 0 0 0 0 0 0 + 974 334 0 5 0 0 22 0 + 975 373 0 6 131 8 0 0 + 976 319 17 0 0 1 0 0 + 977 100 0 2 130 4 0 0 + 978 74 0 0 0 0 0 0 + 979 334 0 5 0 0 17 0 + 980 373 0 6 129 8 0 0 + 981 319 11 0 0 1 0 0 + 982 100 0 2 128 4 0 0 + 983 74 0 0 0 0 0 0 + 984 334 0 5 0 0 11 0 + 985 373 0 6 127 8 0 0 + 986 319 24 0 0 1 0 0 + 987 100 0 2 126 4 0 0 + 988 74 0 0 0 0 0 0 + 989 334 0 5 0 0 24 0 + 990 373 0 6 125 8 0 0 + 991 319 7 0 0 1 0 0 + 992 100 0 2 124 4 0 0 + 993 74 0 0 0 0 0 0 + 994 334 0 5 0 0 7 0 + 995 373 0 6 123 8 0 0 + 996 319 20 0 0 1 0 0 + 997 100 0 2 122 4 0 0 + 998 74 0 0 0 0 0 0 + 999 334 0 5 0 0 20 0 +1000 373 0 6 121 8 0 0 +1001 319 20 0 0 1 0 0 +1002 100 0 2 120 4 0 0 +1003 74 0 0 0 0 0 0 +1004 334 0 5 0 0 20 0 +1005 373 0 6 119 8 0 0 +1006 319 7 0 0 1 0 0 +1007 100 0 2 118 4 0 0 +1008 74 0 0 0 0 0 0 +1009 334 0 5 0 0 7 0 +1010 373 0 6 117 8 0 0 +1011 319 24 0 0 1 0 0 +1012 100 0 2 116 4 0 0 +1013 74 0 0 0 0 0 0 +1014 334 0 5 0 0 24 0 +1015 373 0 6 115 8 0 0 +1016 319 11 0 0 1 0 0 +1017 100 0 2 114 4 0 0 +1018 74 0 0 0 0 0 0 +1019 334 0 5 0 0 11 0 +1020 373 0 6 113 8 0 0 +1021 319 17 0 0 1 0 0 +1022 100 0 2 112 4 0 0 +1023 74 0 0 0 0 0 0 +1024 334 0 5 0 0 17 0 +1025 373 0 6 111 8 0 0 +1026 319 22 0 0 1 0 0 +1027 100 0 2 110 4 0 0 +1028 74 0 0 0 0 0 0 +1029 334 0 5 0 0 22 0 +1030 373 0 6 109 8 0 0 +1031 319 2 0 0 1 0 0 +1032 100 0 2 108 4 0 0 +1033 74 0 0 0 0 0 0 +1034 334 0 5 0 0 2 0 +1035 373 0 6 107 8 0 0 +1036 319 23 0 0 1 0 0 +1037 100 0 2 106 4 0 0 +1038 74 0 0 0 0 0 0 +1039 334 0 5 0 0 23 0 +1040 373 0 6 105 8 0 0 +1041 319 15 0 0 1 0 0 +1042 100 0 2 104 4 0 0 +1043 74 0 0 0 0 0 0 +1044 334 0 5 0 0 15 0 +1045 373 0 6 103 8 0 0 +1046 319 14 0 0 1 0 0 +1047 100 0 2 102 4 0 0 +1048 74 0 0 0 0 0 0 +1049 334 0 5 0 0 14 0 +1050 373 0 6 101 8 0 0 +1051 319 22 0 0 1 0 0 +1052 100 0 2 100 4 0 0 +1053 74 0 0 0 0 0 0 +1054 334 0 5 0 0 22 0 +1055 373 0 6 99 8 0 0 +1056 319 4 0 0 1 0 0 +1057 100 0 2 98 4 0 0 +1058 74 0 0 0 0 0 0 +1059 334 0 5 0 0 4 0 +1060 373 0 6 97 8 0 0 +1061 319 21 0 0 1 0 0 +1062 100 0 2 96 4 0 0 +1063 74 0 0 0 0 0 0 +1064 334 0 5 0 0 21 0 +1065 373 0 6 95 8 0 0 +1066 319 18 0 0 1 0 0 +1067 100 0 2 94 4 0 0 +1068 74 0 0 0 0 0 0 +1069 334 0 5 0 0 18 0 +1070 373 0 6 93 8 0 0 +1071 319 10 0 0 1 0 0 +1072 100 0 2 92 4 0 0 +1073 74 0 0 0 0 0 0 +1074 334 0 5 0 0 10 0 +1075 373 0 6 91 8 0 0 +1076 319 20 0 0 1 0 0 +1077 100 0 2 90 4 0 0 +1078 74 0 0 0 0 0 0 +1079 334 0 5 0 0 20 0 +1080 373 0 6 89 8 0 0 +1081 319 9 0 0 1 0 0 +1082 100 0 2 88 4 0 0 +1083 74 0 0 0 0 0 0 +1084 334 0 5 0 0 9 0 +1085 373 0 6 87 8 0 0 +1086 319 19 0 0 1 0 0 +1087 100 0 2 86 4 0 0 +1088 74 0 0 0 0 0 0 +1089 334 0 5 0 0 19 0 +1090 373 0 6 85 8 0 0 +1091 319 18 0 0 1 0 0 +1092 100 0 2 84 4 0 0 +1093 74 0 0 0 0 0 0 +1094 334 0 5 0 0 18 0 +1095 373 0 6 83 8 0 0 +1096 319 5 0 0 1 0 0 +1097 100 0 2 82 4 0 0 +1098 74 0 0 0 0 0 0 +1099 334 0 5 0 0 5 0 +1100 373 0 6 81 8 0 0 +1101 319 17 0 0 1 0 0 +1102 100 0 2 80 4 0 0 +1103 74 0 0 0 0 0 0 +1104 334 0 5 0 0 17 0 +1105 373 0 6 79 8 0 0 +1106 319 13 0 0 1 0 0 +1107 100 0 2 78 4 0 0 +1108 74 0 0 0 0 0 0 +1109 334 0 5 0 0 13 0 +1110 373 0 6 77 8 0 0 +1111 319 16 0 0 1 0 0 +1112 100 0 2 76 4 0 0 +1113 74 0 0 0 0 0 0 +1114 334 0 5 0 0 16 0 +1115 373 0 6 75 8 0 0 +1116 319 15 0 0 1 0 0 +1117 100 0 2 74 4 0 0 +1118 74 0 0 0 0 0 0 +1119 334 0 5 0 0 15 0 +1120 373 0 6 73 8 0 0 +1121 319 1 0 0 1 0 0 +1122 100 0 2 72 4 0 0 +1123 74 0 0 0 0 0 0 +1124 334 0 5 0 0 1 0 +1125 373 0 6 71 8 0 0 +1126 319 14 0 0 1 0 0 +1127 100 0 2 70 4 0 0 +1128 74 0 0 0 0 0 0 +1129 334 0 5 0 0 14 0 +1130 373 0 6 69 8 0 0 +1131 319 13 0 0 1 0 0 +1132 100 0 2 68 4 0 0 +1133 74 0 0 0 0 0 0 +1134 334 0 5 0 0 13 0 +1135 373 0 6 67 8 0 0 +1136 319 12 0 0 1 0 0 +1137 100 0 2 66 4 0 0 +1138 74 0 0 0 0 0 0 +1139 334 0 5 0 0 12 0 +1140 373 0 6 65 8 0 0 +1141 319 11 0 0 1 0 0 +1142 100 0 2 64 4 0 0 +1143 74 0 0 0 0 0 0 +1144 334 0 5 0 0 11 0 +1145 373 0 6 63 8 0 0 +1146 319 6 0 0 1 0 0 +1147 100 0 2 62 4 0 0 +1148 74 0 0 0 0 0 0 +1149 334 0 5 0 0 6 0 +1150 373 0 6 61 8 0 0 +1151 319 10 0 0 1 0 0 +1152 100 0 2 60 4 0 0 +1153 74 0 0 0 0 0 0 +1154 334 0 5 0 0 10 0 +1155 373 0 6 59 8 0 0 +1156 319 9 0 0 1 0 0 +1157 100 0 2 58 4 0 0 +1158 74 0 0 0 0 0 0 +1159 334 0 5 0 0 9 0 +1160 373 0 6 57 8 0 0 +1161 319 8 0 0 1 0 0 +1162 100 0 2 56 4 0 0 +1163 74 0 0 0 0 0 0 +1164 334 0 5 0 0 8 0 +1165 373 0 6 55 8 0 0 +1166 319 7 0 0 1 0 0 +1167 100 0 2 54 4 0 0 +1168 74 0 0 0 0 0 0 +1169 334 0 5 0 0 7 0 +1170 373 0 6 53 8 0 0 +1171 319 6 0 0 1 0 0 +1172 100 0 2 52 4 0 0 +1173 74 0 0 0 0 0 0 +1174 334 0 5 0 0 6 0 +1175 373 0 6 51 8 0 0 +1176 319 5 0 0 1 0 0 +1177 100 0 2 50 4 0 0 +1178 74 0 0 0 0 0 0 +1179 334 0 5 0 0 5 0 +1180 373 0 6 49 8 0 0 +1181 319 4 0 0 1 0 0 +1182 100 0 2 48 4 0 0 +1183 74 0 0 0 0 0 0 +1184 334 0 5 0 0 4 0 +1185 373 0 6 47 8 0 0 +1186 319 3 0 0 1 0 0 +1187 100 0 2 46 4 0 0 +1188 74 0 0 0 0 0 0 +1189 334 0 5 0 0 3 0 +1190 373 0 6 45 8 0 0 +1191 319 2 0 0 1 0 0 +1192 100 0 2 44 4 0 0 +1193 74 0 0 0 0 0 0 +1194 334 0 5 0 0 2 0 +1195 373 0 6 43 8 0 0 +1196 319 1 0 0 1 0 0 +1197 100 0 2 42 4 0 0 +1198 74 0 0 0 0 0 0 +1199 334 0 5 0 0 1 0 +1200 373 0 6 41 8 0 0 +1201 319 1 0 0 1 0 0 +1202 100 0 2 40 4 0 0 +1203 74 0 0 0 0 0 0 +1204 334 0 5 0 0 1 0 +1205 373 0 6 39 8 0 0 +1206 319 2 0 0 1 0 0 +1207 100 0 2 38 4 0 0 +1208 74 0 0 0 0 0 0 +1209 334 0 5 0 0 2 0 +1210 373 0 6 37 8 0 0 +1211 319 3 0 0 1 0 0 +1212 100 0 2 36 4 0 0 +1213 74 0 0 0 0 0 0 +1214 334 0 5 0 0 3 0 +1215 373 0 6 35 8 0 0 +1216 319 4 0 0 1 0 0 +1217 100 0 2 34 4 0 0 +1218 74 0 0 0 0 0 0 +1219 334 0 5 0 0 4 0 +1220 373 0 6 33 8 0 0 +1221 319 5 0 0 1 0 0 +1222 100 0 2 32 4 0 0 +1223 74 0 0 0 0 0 0 +1224 334 0 5 0 0 5 0 +1225 373 0 6 31 8 0 0 +1226 319 6 0 0 1 0 0 +1227 100 0 2 30 4 0 0 +1228 74 0 0 0 0 0 0 +1229 334 0 5 0 0 6 0 +1230 373 0 6 29 8 0 0 +1231 319 7 0 0 1 0 0 +1232 100 0 2 28 4 0 0 +1233 74 0 0 0 0 0 0 +1234 334 0 5 0 0 7 0 +1235 373 0 6 27 8 0 0 +1236 319 8 0 0 1 0 0 +1237 100 0 2 26 4 0 0 +1238 74 0 0 0 0 0 0 +1239 334 0 5 0 0 8 0 +1240 373 0 6 25 8 0 0 +1241 319 9 0 0 1 0 0 +1242 100 0 2 24 4 0 0 +1243 74 0 0 0 0 0 0 +1244 334 0 5 0 0 9 0 +1245 373 0 6 23 8 0 0 +1246 319 10 0 0 1 0 0 +1247 100 0 2 22 4 0 0 +1248 74 0 0 0 0 0 0 +1249 334 0 5 0 0 10 0 +1250 373 0 6 21 8 0 0 +1251 319 6 0 0 1 0 0 +1252 100 0 2 20 4 0 0 +1253 74 0 0 0 0 0 0 +1254 334 0 5 0 0 6 0 +1255 373 0 6 19 8 0 0 +1256 319 11 0 0 1 0 0 +1257 100 0 2 18 4 0 0 +1258 74 0 0 0 0 0 0 +1259 334 0 5 0 0 11 0 +1260 373 0 6 17 8 0 0 +1261 319 12 0 0 1 0 0 +1262 100 0 2 16 4 0 0 +1263 74 0 0 0 0 0 0 +1264 334 0 5 0 0 12 0 +1265 373 0 6 15 8 0 0 +1266 319 13 0 0 1 0 0 +1267 100 0 2 14 4 0 0 +1268 74 0 0 0 0 0 0 +1269 334 0 5 0 0 13 0 +1270 373 0 6 13 8 0 0 +1271 319 14 0 0 1 0 0 +1272 100 0 2 12 4 0 0 +1273 74 0 0 0 0 0 0 +1274 334 0 5 0 0 14 0 +1275 373 0 6 11 8 0 0 +1276 319 1 0 0 1 0 0 +1277 100 0 2 10 4 0 0 +1278 74 0 0 0 0 0 0 +1279 334 0 5 0 0 1 0 +1280 373 0 6 9 8 0 0 + +# Format of RF events: +# id amplitude mag_id phase_id time_shape_id delay freq phase +# .. Hz .... .... .... us Hz rad +[RF] +1 37.2185 1 2 0 100 0 0 +2 37.2185 1 2 0 100 0 2.04204 +3 37.2185 1 2 0 100 0 6.12611 +4 37.2185 1 2 0 100 0 5.96903 +5 37.2185 1 2 0 100 0 1.5708 +6 37.2185 1 2 0 100 0 5.49779 +7 37.2185 1 2 0 100 0 5.18363 +8 37.2185 1 2 0 100 0 0.628319 +9 37.2185 1 2 0 100 0 4.39823 +10 37.2185 1 2 0 100 0 3.92699 +11 37.2185 1 2 0 100 0 2.82743 +12 37.2185 1 2 0 100 0 2.19911 +13 37.2185 1 2 0 100 0 3.61283 +14 37.2185 1 2 0 100 0 0.785398 +15 37.2185 1 2 0 100 0 1.25664 +16 37.2185 1 2 0 100 0 4.55531 +17 37.2185 1 2 0 100 0 4.71239 +18 37.2185 1 2 0 100 0 0.471239 +19 37.2185 1 2 0 100 0 1.41372 +20 37.2185 1 2 0 100 0 3.14159 +21 37.2185 1 2 0 100 0 5.34071 +22 37.2185 1 2 0 100 0 2.35619 +23 37.2185 1 2 0 100 0 3.76991 +24 37.2185 1 2 0 100 0 2.98451 + +# Format of trapezoid gradients: +# id amplitude rise flat fall delay +# .. Hz/m us us us us +[TRAP] + 1 444444 90 3000 90 10 + 2 -580611 120 760 120 0 + 3 -561798 110 780 110 0 + 4 -827309 170 660 170 0 + 5 312500 70 3200 70 0 + 6 934579 190 1950 190 0 + 7 561798 110 780 110 0 + 8 932401 190 1240 190 0 + 9 -557409 110 780 110 0 +10 557409 110 780 110 0 +11 -553020 110 780 110 0 +12 553020 110 780 110 0 +13 -548631 110 780 110 0 +14 548631 110 780 110 0 +15 -544242 110 780 110 0 +16 544242 110 780 110 0 +17 -539853 110 780 110 0 +18 539853 110 780 110 0 +19 -535463 110 780 110 0 +20 535463 110 780 110 0 +21 -531074 110 780 110 0 +22 531074 110 780 110 0 +23 -526685 110 780 110 0 +24 526685 110 780 110 0 +25 -522296 110 780 110 0 +26 522296 110 780 110 0 +27 -517907 110 780 110 0 +28 517907 110 780 110 0 +29 -513518 110 780 110 0 +30 513518 110 780 110 0 +31 -509129 110 780 110 0 +32 509129 110 780 110 0 +33 -504740 110 780 110 0 +34 504740 110 780 110 0 +35 -500351 110 780 110 0 +36 500351 110 780 110 0 +37 -495962 110 780 110 0 +38 495962 110 780 110 0 +39 -491573 110 780 110 0 +40 491573 110 780 110 0 +41 -487184 110 780 110 0 +42 487184 110 780 110 0 +43 -482795 110 780 110 0 +44 482795 110 780 110 0 +45 -478406 110 780 110 0 +46 478406 110 780 110 0 +47 -474017 110 780 110 0 +48 474017 110 780 110 0 +49 -469628 110 780 110 0 +50 469628 110 780 110 0 +51 -465239 110 780 110 0 +52 465239 110 780 110 0 +53 -460850 110 780 110 0 +54 460850 110 780 110 0 +55 -456461 110 780 110 0 +56 456461 110 780 110 0 +57 -452072 110 780 110 0 +58 452072 110 780 110 0 +59 -447683 110 780 110 0 +60 447683 110 780 110 0 +61 -443294 110 780 110 0 +62 443294 110 780 110 0 +63 -438904 110 780 110 0 +64 438904 110 780 110 0 +65 -434515 110 780 110 0 +66 434515 110 780 110 0 +67 -430126 110 780 110 0 +68 430126 110 780 110 0 +69 -425737 110 780 110 0 +70 425737 110 780 110 0 +71 -421348 110 780 110 0 +72 421348 110 780 110 0 +73 -416959 110 780 110 0 +74 416959 110 780 110 0 +75 -412570 110 780 110 0 +76 412570 110 780 110 0 +77 -408181 110 780 110 0 +78 408181 110 780 110 0 +79 -403792 110 780 110 0 +80 403792 110 780 110 0 +81 -399403 110 780 110 0 +82 399403 110 780 110 0 +83 -395014 110 780 110 0 +84 395014 110 780 110 0 +85 -390625 110 780 110 0 +86 390625 110 780 110 0 +87 -386236 110 780 110 0 +88 386236 110 780 110 0 +89 -381847 110 780 110 0 +90 381847 110 780 110 0 +91 -377458 110 780 110 0 +92 377458 110 780 110 0 +93 -373069 110 780 110 0 +94 373069 110 780 110 0 +95 -368680 110 780 110 0 +96 368680 110 780 110 0 +97 -364291 110 780 110 0 +98 364291 110 780 110 0 +99 -359902 110 780 110 0 +100 359902 110 780 110 0 +101 -355513 110 780 110 0 +102 355513 110 780 110 0 +103 -351124 110 780 110 0 +104 351124 110 780 110 0 +105 -346735 110 780 110 0 +106 346735 110 780 110 0 +107 -342346 110 780 110 0 +108 342346 110 780 110 0 +109 -337956 110 780 110 0 +110 337956 110 780 110 0 +111 -333567 110 780 110 0 +112 333567 110 780 110 0 +113 -329178 110 780 110 0 +114 329178 110 780 110 0 +115 -324789 110 780 110 0 +116 324789 110 780 110 0 +117 -320400 110 780 110 0 +118 320400 110 780 110 0 +119 -316011 110 780 110 0 +120 316011 110 780 110 0 +121 -311622 110 780 110 0 +122 311622 110 780 110 0 +123 -307233 110 780 110 0 +124 307233 110 780 110 0 +125 -302844 110 780 110 0 +126 302844 110 780 110 0 +127 -298455 110 780 110 0 +128 298455 110 780 110 0 +129 -294066 110 780 110 0 +130 294066 110 780 110 0 +131 -289677 110 780 110 0 +132 289677 110 780 110 0 +133 -285288 110 780 110 0 +134 285288 110 780 110 0 +135 -280899 110 780 110 0 +136 280899 110 780 110 0 +137 -276510 110 780 110 0 +138 276510 110 780 110 0 +139 -272121 110 780 110 0 +140 272121 110 780 110 0 +141 -267732 110 780 110 0 +142 267732 110 780 110 0 +143 -263343 110 780 110 0 +144 263343 110 780 110 0 +145 -258954 110 780 110 0 +146 258954 110 780 110 0 +147 -254565 110 780 110 0 +148 254565 110 780 110 0 +149 -250176 110 780 110 0 +150 250176 110 780 110 0 +151 -245787 110 780 110 0 +152 245787 110 780 110 0 +153 -241397 110 780 110 0 +154 241397 110 780 110 0 +155 -237008 110 780 110 0 +156 237008 110 780 110 0 +157 -232619 110 780 110 0 +158 232619 110 780 110 0 +159 -228230 110 780 110 0 +160 228230 110 780 110 0 +161 -223841 110 780 110 0 +162 223841 110 780 110 0 +163 -219452 110 780 110 0 +164 219452 110 780 110 0 +165 -215063 110 780 110 0 +166 215063 110 780 110 0 +167 -210674 110 780 110 0 +168 210674 110 780 110 0 +169 -206285 110 780 110 0 +170 206285 110 780 110 0 +171 -201896 110 780 110 0 +172 201896 110 780 110 0 +173 -197507 110 780 110 0 +174 197507 110 780 110 0 +175 -193118 110 780 110 0 +176 193118 110 780 110 0 +177 -188729 110 780 110 0 +178 188729 110 780 110 0 +179 -184340 110 780 110 0 +180 184340 110 780 110 0 +181 -179951 110 780 110 0 +182 179951 110 780 110 0 +183 -175562 110 780 110 0 +184 175562 110 780 110 0 +185 -171173 110 780 110 0 +186 171173 110 780 110 0 +187 -166784 110 780 110 0 +188 166784 110 780 110 0 +189 -162395 110 780 110 0 +190 162395 110 780 110 0 +191 -158006 110 780 110 0 +192 158006 110 780 110 0 +193 -153617 110 780 110 0 +194 153617 110 780 110 0 +195 -149228 110 780 110 0 +196 149228 110 780 110 0 +197 -144838 110 780 110 0 +198 144838 110 780 110 0 +199 -140449 110 780 110 0 +200 140449 110 780 110 0 +201 -136060 110 780 110 0 +202 136060 110 780 110 0 +203 -131671 110 780 110 0 +204 131671 110 780 110 0 +205 -127282 110 780 110 0 +206 127282 110 780 110 0 +207 -122893 110 780 110 0 +208 122893 110 780 110 0 +209 -118504 110 780 110 0 +210 118504 110 780 110 0 +211 -114115 110 780 110 0 +212 114115 110 780 110 0 +213 -109726 110 780 110 0 +214 109726 110 780 110 0 +215 -105337 110 780 110 0 +216 105337 110 780 110 0 +217 -100948 110 780 110 0 +218 100948 110 780 110 0 +219 -96559 110 780 110 0 +220 96559 110 780 110 0 +221 -92169.9 110 780 110 0 +222 92169.9 110 780 110 0 +223 -87780.9 110 780 110 0 +224 87780.9 110 780 110 0 +225 -83391.9 110 780 110 0 +226 83391.9 110 780 110 0 +227 -79002.8 110 780 110 0 +228 79002.8 110 780 110 0 +229 -74613.8 110 780 110 0 +230 74613.8 110 780 110 0 +231 -70224.7 110 780 110 0 +232 70224.7 110 780 110 0 +233 -65835.7 110 780 110 0 +234 65835.7 110 780 110 0 +235 -61446.6 110 780 110 0 +236 61446.6 110 780 110 0 +237 -57057.6 110 780 110 0 +238 57057.6 110 780 110 0 +239 -52668.5 110 780 110 0 +240 52668.5 110 780 110 0 +241 -48279.5 110 780 110 0 +242 48279.5 110 780 110 0 +243 -43890.4 110 780 110 0 +244 43890.4 110 780 110 0 +245 -39501.4 110 780 110 0 +246 39501.4 110 780 110 0 +247 -35112.4 110 780 110 0 +248 35112.4 110 780 110 0 +249 -30723.3 110 780 110 0 +250 30723.3 110 780 110 0 +251 -26334.3 110 780 110 0 +252 26334.3 110 780 110 0 +253 -21945.2 110 780 110 0 +254 21945.2 110 780 110 0 +255 -17556.2 110 780 110 0 +256 17556.2 110 780 110 0 +257 -13167.1 110 780 110 0 +258 13167.1 110 780 110 0 +259 -8778.09 110 780 110 0 +260 8778.09 110 780 110 0 +261 -4389.04 110 780 110 0 +262 4389.04 110 780 110 0 +263 0 110 780 110 0 +264 -0 110 780 110 0 + +# Format of ADC events: +# id num dwell delay freq phase +# .. .. ns us Hz rad +[ADC] +1 256 12500 70 0 0 +2 256 12500 70 0 2.04204 +3 256 12500 70 0 6.12611 +4 256 12500 70 0 5.96903 +5 256 12500 70 0 1.5708 +6 256 12500 70 0 5.49779 +7 256 12500 70 0 5.18363 +8 256 12500 70 0 0.628319 +9 256 12500 70 0 4.39823 +10 256 12500 70 0 3.92699 +11 256 12500 70 0 2.82743 +12 256 12500 70 0 2.19911 +13 256 12500 70 0 3.61283 +14 256 12500 70 0 0.785398 +15 256 12500 70 0 1.25664 +16 256 12500 70 0 4.55531 +17 256 12500 70 0 4.71239 +18 256 12500 70 0 0.471239 +19 256 12500 70 0 1.41372 +20 256 12500 70 0 3.14159 +21 256 12500 70 0 5.34071 +22 256 12500 70 0 2.35619 +23 256 12500 70 0 3.76991 +24 256 12500 70 0 2.98451 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 3000 +5.33512061e-05 +0.000160161335 +0.000267116839 +0.000374219827 +0.000481472412 +0.000588876712 +0.00069643485 +0.000804148955 +0.000912021157 +0.00102005359 +0.0011282484 +0.00123660773 +0.00134513373 +0.00145382854 +0.00156269432 +0.00167173322 +0.00178094741 +0.00189033905 +0.0019999103 +0.00210966333 +0.00221960031 +0.00232972341 +0.00244003479 +0.00255053664 +0.00266123112 +0.00277212042 +0.0028832067 +0.00299449215 +0.00310597893 +0.00321766924 +0.00332956523 +0.0034416691 +0.00355398301 +0.00366650915 +0.00377924967 +0.00389220677 +0.0040053826 +0.00411877934 +0.00423239915 +0.00434624421 +0.00446031667 +0.0045746187 +0.00468915245 +0.00480392009 +0.00491892375 +0.0050341656 +0.00514964778 +0.00526537242 +0.00538134167 +0.00549755767 +0.00561402253 +0.00573073839 +0.00584770736 +0.00596493156 +0.0060824131 +0.00620015408 +0.0063181566 +0.00643642275 +0.00655495462 +0.00667375429 +0.00679282382 +0.0069121653 +0.00703178077 +0.00715167228 +0.00727184189 +0.00739229163 +0.00751302352 +0.00763403959 +0.00775534184 +0.00787693229 +0.00799881293 +0.00812098573 +0.00824345268 +0.00836621575 +0.00848927689 +0.00861263804 +0.00873630115 +0.00886026813 +0.00898454092 +0.0091091214 +0.00923401147 +0.00935921303 +0.00948472792 +0.00961055802 +0.00973670518 +0.00986317122 +0.00998995796 +0.0101170672 +0.0102445008 +0.0103722605 +0.010500348 +0.0106287652 +0.0107575137 +0.0108865953 +0.0110160118 +0.0111457647 +0.0112758559 +0.0114062868 +0.0115370594 +0.011668175 +0.0117996355 +0.0119314423 +0.0120635972 +0.0121961015 +0.012328957 +0.0124621652 +0.0125957275 +0.0127296456 +0.0128639208 +0.0129985546 +0.0131335486 +0.0132689041 +0.0134046226 +0.0135407055 +0.013677154 +0.0138139698 +0.0139511539 +0.0140887078 +0.0142266329 +0.0143649302 +0.0145036012 +0.0146426471 +0.0147820691 +0.0149218683 +0.0150620461 +0.0152026035 +0.0153435416 +0.0154848617 +0.0156265647 +0.0157686518 +0.015911124 +0.0160539824 +0.0161972279 +0.0163408615 +0.0164848842 +0.016629297 +0.0167741007 +0.0169192962 +0.0170648843 +0.0172108661 +0.0173572421 +0.0175040133 +0.0176511804 +0.0177987441 +0.0179467052 +0.0180950644 +0.0182438222 +0.0183929794 +0.0185425366 +0.0186924943 +0.0188428531 +0.0189936136 +0.0191447761 +0.0192963414 +0.0194483097 +0.0196006814 +0.0197534571 +0.019906637 +0.0200602216 +0.020214211 +0.0203686056 +0.0205234057 +0.0206786114 +0.020834223 +0.0209902406 +0.0211466644 +0.0213034945 +0.0214607308 +0.0216183736 +0.0217764228 +0.0219348784 +0.0220937403 +0.0222530084 +0.0224126827 +0.0225727631 +0.0227332492 +0.022894141 +0.0230554382 +0.0232171406 +0.0233792478 +0.0235417594 +0.0237046752 +0.0238679948 +0.0240317176 +0.0241958433 +0.0243603714 +0.0245253012 +0.0246906323 +0.0248563641 +0.0250224958 +0.0251890269 +0.0253559566 +0.0255232843 +0.025691009 +0.0258591301 +0.0260276467 +0.0261965579 +0.0263658627 +0.0265355603 +0.0267056496 +0.0268761297 +0.0270469995 +0.0272182578 +0.0273899036 +0.0275619356 +0.0277343527 +0.0279071537 +0.0280803372 +0.028253902 +0.0284278466 +0.0286021697 +0.0287768699 +0.0289519457 +0.0291273956 +0.029303218 +0.0294794114 +0.0296559741 +0.0298329045 +0.0300102009 +0.0301878615 +0.0303658846 +0.0305442683 +0.0307230109 +0.0309021103 +0.0310815647 +0.0312613721 +0.0314415304 +0.0316220377 +0.0318028918 +0.0319840905 +0.0321656318 +0.0323475134 +0.032529733 +0.0327122883 +0.032895177 +0.0330783967 +0.033261945 +0.0334458194 +0.0336300174 +0.0338145364 +0.033999374 +0.0341845274 +0.0343699939 +0.0345557709 +0.0347418555 +0.0349282451 +0.0351149367 +0.0353019274 +0.0354892144 +0.0356767946 +0.035864665 +0.0360528226 +0.0362412643 +0.036429987 +0.0366189873 +0.0368082622 +0.0369978083 +0.0371876223 +0.0373777009 +0.0375680406 +0.037758638 +0.0379494896 +0.0381405919 +0.0383319412 +0.038523534 +0.0387153666 +0.0389074352 +0.0390997361 +0.0392922655 +0.0394850196 +0.0396779943 +0.0398711859 +0.0400645904 +0.0402582036 +0.0404520215 +0.04064604 +0.0408402549 +0.0410346621 +0.0412292572 +0.041424036 +0.0416189941 +0.0418141271 +0.0420094306 +0.0422049002 +0.0424005311 +0.042596319 +0.0427922591 +0.0429883469 +0.0431845775 +0.0433809463 +0.0435774484 +0.043774079 +0.0439708332 +0.044167706 +0.0443646925 +0.0445617876 +0.0447589862 +0.0449562833 +0.0451536736 +0.0453511519 +0.0455487129 +0.0457463514 +0.045944062 +0.0461418393 +0.0463396777 +0.0465375719 +0.0467355163 +0.0469335053 +0.0471315333 +0.0473295945 +0.0475276832 +0.0477257938 +0.0479239202 +0.0481220568 +0.0483201975 +0.0485183364 +0.0487164674 +0.0489145847 +0.0491126819 +0.0493107531 +0.0495087919 +0.0497067922 +0.0499047476 +0.0501026519 +0.0503004986 +0.0504982813 +0.0506959936 +0.0508936289 +0.0510911807 +0.0512886424 +0.0514860072 +0.0516832685 +0.0518804196 +0.0520774536 +0.0522743638 +0.0524711431 +0.0526677847 +0.0528642817 +0.0530606269 +0.0532568133 +0.0534528338 +0.0536486812 +0.0538443484 +0.054039828 +0.0542351127 +0.0544301953 +0.0546250683 +0.0548197242 +0.0550141557 +0.0552083552 +0.055402315 +0.0555960276 +0.0557894854 +0.0559826805 +0.0561756053 +0.056368252 +0.0565606126 +0.0567526794 +0.0569444444 +0.0571358996 +0.057327037 +0.0575178486 +0.0577083261 +0.0578984615 +0.0580882466 +0.058277673 +0.0584667326 +0.0586554171 +0.0588437179 +0.0590316268 +0.0592191352 +0.0594062346 +0.0595929165 +0.0597791724 +0.0599649935 +0.0601503711 +0.0603352967 +0.0605197613 +0.0607037563 +0.0608872727 +0.0610703017 +0.0612528342 +0.0614348615 +0.0616163743 +0.0617973638 +0.0619778207 +0.0621577359 +0.0623371003 +0.0625159045 +0.0626941395 +0.0628717957 +0.063048864 +0.0632253349 +0.0634011989 +0.0635764466 +0.0637510686 +0.0639250551 +0.0640983967 +0.0642710837 +0.0644431065 +0.0646144553 +0.0647851204 +0.0649550919 +0.0651243601 +0.0652929152 +0.0654607471 +0.0656278459 +0.0657942017 +0.0659598045 +0.0661246441 +0.0662887106 +0.0664519936 +0.0666144832 +0.066776169 +0.0669370408 +0.0670970884 +0.0672563014 +0.0674146694 +0.0675721821 +0.0677288291 +0.0678845998 +0.0680394838 +0.0681934705 +0.0683465494 +0.0684987098 +0.0686499411 +0.0688002327 +0.0689495738 +0.0690979537 +0.0692453615 +0.0693917866 +0.0695372179 +0.0696816448 +0.0698250561 +0.0699674411 +0.0701087887 +0.0702490879 +0.0703883276 +0.0705264968 +0.0706635844 +0.0707995792 +0.07093447 +0.0710682457 +0.071200895 +0.0713324067 +0.0714627694 +0.0715919719 +0.0717200028 +0.0718468506 +0.071972504 +0.0720969516 +0.0722201818 +0.0723421832 +0.0724629442 +0.0725824532 +0.0727006988 +0.0728176692 +0.0729333529 +0.0730477381 +0.0731608132 +0.0732725665 +0.0733829861 +0.0734920604 +0.0735997774 +0.0737061255 +0.0738110928 +0.0739146673 +0.0740168372 +0.0741175905 +0.0742169153 +0.0743147997 +0.0744112315 +0.0745061989 +0.0745996898 +0.074691692 +0.0747821936 +0.0748711824 +0.0749586462 +0.075044573 +0.0751289505 +0.0752117665 +0.0752930089 +0.0753726654 +0.0754507237 +0.0755271716 +0.0756019967 +0.0756751868 +0.0757467295 +0.0758166125 +0.0758848234 +0.0759513498 +0.0760161793 +0.0760792995 +0.0761406979 +0.076200362 +0.0762582795 +0.0763144379 +0.0763688245 +0.0764214269 +0.0764722326 +0.076521229 +0.0765684036 +0.0766137437 +0.0766572368 +0.0766988703 +0.0767386316 +0.0767765079 +0.0768124868 +0.0768465554 +0.0768787013 +0.0769089116 +0.0769371737 +0.076963475 +0.0769878026 +0.0770101438 +0.077030486 +0.0770488165 +0.0770651223 +0.0770793909 +0.0770916094 +0.077101765 +0.0771098451 +0.0771158367 +0.0771197271 +0.0771215035 +0.0771211531 +0.0771186631 +0.0771140207 +0.077107213 +0.0770982273 +0.0770870506 +0.0770736701 +0.0770580731 +0.0770402467 +0.0770201779 +0.0769978541 +0.0769732623 +0.0769463896 +0.0769172233 +0.0768857505 +0.0768519583 +0.0768158339 +0.0767773643 +0.0767365369 +0.0766933386 +0.0766477567 +0.0765997784 +0.0765493907 +0.0764965808 +0.0764413358 +0.0763836431 +0.0763234896 +0.0762608626 +0.0761957493 +0.0761281368 +0.0760580122 +0.0759853629 +0.075910176 +0.0758324387 +0.0757521382 +0.0756692617 +0.0755837964 +0.0754957297 +0.0754050486 +0.0753117405 +0.0752157926 +0.0751171921 +0.0750159265 +0.0749119829 +0.0748053486 +0.0746960109 +0.0745839573 +0.0744691749 +0.0743516512 +0.0742313734 +0.074108329 +0.0739825054 +0.0738538899 +0.07372247 +0.073588233 +0.0734511665 +0.0733112578 +0.0731684945 +0.0730228641 +0.0728743539 +0.0727229516 +0.0725686447 +0.0724114208 +0.0722512674 +0.0720881722 +0.0719221226 +0.0717531065 +0.0715811113 +0.0714061249 +0.0712281348 +0.0710471289 +0.0708630948 +0.0706760203 +0.0704858932 +0.0702927013 +0.0700964323 +0.0698970743 +0.069694615 +0.0694890423 +0.0692803441 +0.0690685085 +0.0688535234 +0.0686353768 +0.0684140566 +0.0681895511 +0.0679618482 +0.067730936 +0.0674968028 +0.0672594366 +0.0670188257 +0.0667749582 +0.0665278225 +0.0662774069 +0.0660236995 +0.0657666889 +0.0655063633 +0.0652427112 +0.0649757211 +0.0647053813 +0.0644316804 +0.064154607 +0.0638741496 +0.0635902969 +0.0633030374 +0.0630123599 +0.062718253 +0.0624207056 +0.0621197064 +0.0618152443 +0.061507308 +0.0611958866 +0.0608809689 +0.060562544 +0.0602406008 +0.0599151284 +0.0595861158 +0.0592535524 +0.0589174271 +0.0585777293 +0.0582344481 +0.0578875729 +0.0575370931 +0.057182998 +0.056825277 +0.0564639196 +0.0560989154 +0.0557302539 +0.0553579247 +0.0549819174 +0.0546022218 +0.0542188276 +0.0538317245 +0.0534409025 +0.0530463514 +0.0526480611 +0.0522460216 +0.0518402229 +0.0514306552 +0.0510173085 +0.050600173 +0.0501792389 +0.0497544965 +0.0493259362 +0.0488935483 +0.0484573232 +0.0480172514 +0.0475733235 +0.0471255301 +0.0466738617 +0.046218309 +0.0457588629 +0.0452955141 +0.0448282535 +0.044357072 +0.0438819605 +0.04340291 +0.0429199118 +0.0424329568 +0.0419420363 +0.0414471415 +0.0409482637 +0.0404453944 +0.0399385249 +0.0394276467 +0.0389127514 +0.0383938305 +0.0378708757 +0.0373438788 +0.0368128315 +0.0362777257 +0.0357385533 +0.0351953062 +0.0346479766 +0.0340965564 +0.0335410379 +0.0329814132 +0.0324176747 +0.0318498147 +0.0312778257 +0.0307017 +0.0301214303 +0.0295370092 +0.0289484293 +0.0283556834 +0.0277587643 +0.0271576649 +0.0265523781 +0.0259428969 +0.0253292145 +0.024711324 +0.0240892186 +0.0234628916 +0.0228323363 +0.0221975462 +0.0215585148 +0.0209152357 +0.0202677025 +0.0196159089 +0.0189598487 +0.0182995158 +0.0176349041 +0.0169660075 +0.0162928203 +0.0156153365 +0.0149335504 +0.0142474563 +0.0135570485 +0.0128623215 +0.0121632698 +0.011459888 +0.0107521708 +0.010040113 +0.00932370935 +0.0086029548 +0.00787784432 +0.00714837297 +0.00641453591 +0.00567632833 +0.00493374555 +0.00418678294 +0.00343543595 +0.00267970012 +0.00191957106 +0.00115504448 +0.00038611613 +0.000387218116 +0.00116496233 +0.00194712048 +0.00273369648 +0.00352469414 +0.0043201172 +0.00511996931 +0.00592425405 +0.00673297489 +0.00754613524 +0.00836373842 +0.00918578767 +0.0100122861 +0.0108432369 +0.0116786429 +0.0125185071 +0.0133628323 +0.0142116211 +0.0150648763 +0.0159226004 +0.0167847959 +0.0176514651 +0.0185226103 +0.0193982338 +0.0202783376 +0.0211629238 +0.0220519944 +0.0229455511 +0.0238435958 +0.0247461301 +0.0256531556 +0.0265646738 +0.0274806861 +0.0284011939 +0.0293261983 +0.0302557006 +0.0311897016 +0.0321282025 +0.033071204 +0.034018707 +0.0349707121 +0.0359272199 +0.036888231 +0.0378537456 +0.0388237642 +0.0397982869 +0.0407773139 +0.0417608452 +0.0427488808 +0.0437414205 +0.044738464 +0.045740011 +0.0467460612 +0.0477566139 +0.0487716685 +0.0497912243 +0.0508152805 +0.0518438363 +0.0528768905 +0.0539144421 +0.0549564899 +0.0560030326 +0.0570540688 +0.0581095971 +0.0591696158 +0.0602341233 +0.0613031178 +0.0623765975 +0.0634545603 +0.0645370042 +0.0656239271 +0.0667153267 +0.0678112006 +0.0689115463 +0.0700163614 +0.0711256432 +0.0722393889 +0.0733575956 +0.0744802605 +0.0756073804 +0.0767389523 +0.0778749729 +0.0790154388 +0.0801603466 +0.0813096928 +0.0824634736 +0.0836216855 +0.0847843245 +0.0859513867 +0.087122868 +0.0882987643 +0.0894790714 +0.0906637849 +0.0918529004 +0.0930464133 +0.094244319 +0.0954466127 +0.0966532896 +0.0978643447 +0.0990797731 +0.100299569 +0.101523729 +0.102752245 +0.103985114 +0.105222329 +0.106463884 +0.107709775 +0.108959995 +0.110214538 +0.111473398 +0.112736569 +0.114004045 +0.115275819 +0.116551885 +0.117832236 +0.119116866 +0.120405767 +0.121698933 +0.122996357 +0.124298032 +0.125603951 +0.126914106 +0.12822849 +0.129547095 +0.130869914 +0.132196939 +0.133528163 +0.134863577 +0.136203173 +0.137546943 +0.13889488 +0.140246974 +0.141603218 +0.142963602 +0.144328118 +0.145696758 +0.147069513 +0.148446373 +0.149827329 +0.151212373 +0.152601495 +0.153994686 +0.155391937 +0.156793237 +0.158198577 +0.159607948 +0.161021339 +0.162438741 +0.163860143 +0.165285535 +0.166714908 +0.16814825 +0.169585552 +0.171026802 +0.17247199 +0.173921105 +0.175374136 +0.176831072 +0.178291903 +0.179756617 +0.181225202 +0.182697648 +0.184173942 +0.185654073 +0.18713803 +0.188625801 +0.190117373 +0.191612735 +0.193111874 +0.194614779 +0.196121437 +0.197631836 +0.199145963 +0.200663805 +0.202185351 +0.203710586 +0.205239498 +0.206772075 +0.208308302 +0.209848167 +0.211391657 +0.212938757 +0.214489455 +0.216043737 +0.217601589 +0.219162997 +0.220727948 +0.222296427 +0.223868421 +0.225443915 +0.227022894 +0.228605345 +0.230191252 +0.231780602 +0.23337338 +0.23496957 +0.236569158 +0.238172129 +0.239778468 +0.241388159 +0.243001188 +0.244617538 +0.246237195 +0.247860143 +0.249486366 +0.251115848 +0.252748574 +0.254384528 +0.256023693 +0.257666054 +0.259311593 +0.260960296 +0.262612145 +0.264267124 +0.265925216 +0.267586404 +0.269250673 +0.270918004 +0.272588381 +0.274261786 +0.275938203 +0.277617615 +0.279300003 +0.280985351 +0.282673641 +0.284364855 +0.286058975 +0.287755984 +0.289455865 +0.291158597 +0.292864165 +0.294572549 +0.296283731 +0.297997693 +0.299714417 +0.301433884 +0.303156074 +0.304880971 +0.306608554 +0.308338805 +0.310071705 +0.311807234 +0.313545374 +0.315286106 +0.31702941 +0.318775266 +0.320523656 +0.322274559 +0.324027956 +0.325783827 +0.327542153 +0.329302913 +0.331066087 +0.332831656 +0.334599599 +0.336369896 +0.338142526 +0.33991747 +0.341694706 +0.343474214 +0.345255973 +0.347039964 +0.348826164 +0.350614553 +0.352405109 +0.354197813 +0.355992643 +0.357789577 +0.359588594 +0.361389673 +0.363192793 +0.364997931 +0.366805066 +0.368614177 +0.370425242 +0.372238239 +0.374053146 +0.375869941 +0.377688602 +0.379509107 +0.381331434 +0.38315556 +0.384981463 +0.38680912 +0.38863851 +0.390469609 +0.392302395 +0.394136845 +0.395972937 +0.397810647 +0.399649953 +0.401490831 +0.403333259 +0.405177213 +0.407022671 +0.408869609 +0.410718003 +0.41256783 +0.414419067 +0.41627169 +0.418125676 +0.419981001 +0.421837641 +0.423695573 +0.425554772 +0.427415215 +0.429276878 +0.431139736 +0.433003765 +0.434868942 +0.436735242 +0.438602641 +0.440471115 +0.442340638 +0.444211188 +0.446082738 +0.447955265 +0.449828743 +0.451703149 +0.453578457 +0.455454643 +0.457331681 +0.459209547 +0.461088216 +0.462967663 +0.464847862 +0.466728789 +0.468610418 +0.470492725 +0.472375683 +0.474259267 +0.476143453 +0.478028214 +0.479913525 +0.481799361 +0.483685696 +0.485572503 +0.487459759 +0.489347436 +0.491235509 +0.493123953 +0.495012741 +0.496901847 +0.498791245 +0.50068091 +0.502570815 +0.504460934 +0.506351241 +0.508241711 +0.510132315 +0.512023029 +0.513913826 +0.51580468 +0.517695564 +0.519586451 +0.521477316 +0.523368132 +0.525258872 +0.52714951 +0.529040019 +0.530930372 +0.532820543 +0.534710504 +0.53660023 +0.538489693 +0.540378867 +0.542267725 +0.544156239 +0.546044383 +0.54793213 +0.549819452 +0.551706324 +0.553592718 +0.555478606 +0.557363961 +0.559248758 +0.561132967 +0.563016563 +0.564899517 +0.566781803 +0.568663394 +0.570544261 +0.572424379 +0.574303719 +0.576182253 +0.578059956 +0.579936799 +0.581812755 +0.583687796 +0.585561895 +0.587435024 +0.589307156 +0.591178264 +0.59304832 +0.594917296 +0.596785165 +0.598651899 +0.60051747 +0.602381851 +0.604245015 +0.606106933 +0.607967579 +0.609826923 +0.61168494 +0.6135416 +0.615396876 +0.617250741 +0.619103167 +0.620954126 +0.62280359 +0.624651531 +0.626497923 +0.628342736 +0.630185944 +0.632027519 +0.633867432 +0.635705656 +0.637542163 +0.639376925 +0.641209915 +0.643041105 +0.644870467 +0.646697973 +0.648523596 +0.650347307 +0.652169079 +0.653988884 +0.655806695 +0.657622482 +0.65943622 +0.661247879 +0.663057433 +0.664864853 +0.666670112 +0.668473181 +0.670274034 +0.672072642 +0.673868978 +0.675663014 +0.677454722 +0.679244074 +0.681031044 +0.682815602 +0.684597723 +0.686377377 +0.688154537 +0.689929177 +0.691701267 +0.69347078 +0.69523769 +0.697001968 +0.698763587 +0.700522519 +0.702278736 +0.704032212 +0.705782919 +0.707530829 +0.709275916 +0.71101815 +0.712757506 +0.714493956 +0.716227472 +0.717958028 +0.719685595 +0.721410147 +0.723131656 +0.724850096 +0.726565438 +0.728277657 +0.729986724 +0.731692612 +0.733395296 +0.735094747 +0.736790938 +0.738483843 +0.740173435 +0.741859686 +0.74354257 +0.74522206 +0.746898129 +0.748570751 +0.750239898 +0.751905544 +0.753567663 +0.755226227 +0.75688121 +0.758532586 +0.760180327 +0.761824409 +0.763464803 +0.765101484 +0.766734425 +0.768363601 +0.769988984 +0.771610549 +0.773228269 +0.774842118 +0.77645207 +0.7780581 +0.77966018 +0.781258286 +0.782852391 +0.784442469 +0.786028495 +0.787610443 +0.789188287 +0.790762001 +0.79233156 +0.793896938 +0.79545811 +0.797015051 +0.798567734 +0.800116135 +0.801660228 +0.803199988 +0.80473539 +0.806266409 +0.80779302 +0.809315197 +0.810832916 +0.812346151 +0.813854879 +0.815359074 +0.816858711 +0.818353766 +0.819844215 +0.821330032 +0.822811193 +0.824287674 +0.825759451 +0.827226499 +0.828688793 +0.830146311 +0.831599028 +0.833046919 +0.834489961 +0.83592813 +0.837361402 +0.838789753 +0.84021316 +0.841631599 +0.843045047 +0.844453479 +0.845856874 +0.847255206 +0.848648454 +0.850036594 +0.851419602 +0.852797456 +0.854170133 +0.85553761 +0.856899864 +0.858256873 +0.859608613 +0.860955063 +0.862296199 +0.863631999 +0.864962441 +0.866287503 +0.867607162 +0.868921397 +0.870230185 +0.871533504 +0.872831333 +0.87412365 +0.875410433 +0.87669166 +0.87796731 +0.879237362 +0.880501793 +0.881760584 +0.883013712 +0.884261157 +0.885502897 +0.886738912 +0.887969181 +0.889193682 +0.890412396 +0.891625302 +0.892832379 +0.894033607 +0.895228966 +0.896418435 +0.897601995 +0.898779624 +0.899951304 +0.901117014 +0.902276736 +0.903430448 +0.904578131 +0.905719767 +0.906855336 +0.907984817 +0.909108193 +0.910225445 +0.911336552 +0.912441497 +0.91354026 +0.914632822 +0.915719167 +0.916799273 +0.917873124 +0.918940702 +0.920001986 +0.921056961 +0.922105608 +0.923147908 +0.924183844 +0.925213399 +0.926236555 +0.927253293 +0.928263598 +0.929267452 +0.930264837 +0.931255737 +0.932240134 +0.933218012 +0.934189353 +0.935154143 +0.936112362 +0.937063997 +0.938009029 +0.938947443 +0.939879223 +0.940804353 +0.941722817 +0.942634598 +0.943539683 +0.944438054 +0.945329697 +0.946214596 +0.947092736 +0.947964102 +0.948828679 +0.949686452 +0.950537406 +0.951381527 +0.9522188 +0.95304921 +0.953872744 +0.954689387 +0.955499126 +0.956301945 +0.957097832 +0.957886773 +0.958668753 +0.95944376 +0.96021178 +0.9609728 +0.961726807 +0.962473788 +0.963213729 +0.963946619 +0.964672443 +0.965391191 +0.966102849 +0.966807405 +0.967504847 +0.968195163 +0.968878341 +0.969554369 +0.970223235 +0.970884928 +0.971539437 +0.972186749 +0.972826855 +0.973459742 +0.974085399 +0.974703817 +0.975314984 +0.975918889 +0.976515523 +0.977104874 +0.977686933 +0.978261689 +0.978829133 +0.979389255 +0.979942044 +0.980487492 +0.981025588 +0.981556324 +0.98207969 +0.982595678 +0.983104277 +0.98360548 +0.984099278 +0.984585662 +0.985064623 +0.985536154 +0.986000245 +0.98645689 +0.98690608 +0.987347807 +0.987782064 +0.988208843 +0.988628136 +0.989039937 +0.989444238 +0.989841031 +0.990230311 +0.990612071 +0.990986303 +0.991353002 +0.99171216 +0.992063772 +0.992407831 +0.992744332 +0.993073269 +0.993394635 +0.993708426 +0.994014635 +0.994313258 +0.994604289 +0.994887724 +0.995163556 +0.995431782 +0.995692397 +0.995945396 +0.996190775 +0.99642853 +0.996658655 +0.996881148 +0.997096005 +0.997303221 +0.997502794 +0.997694719 +0.997878993 +0.998055614 +0.998224577 +0.99838588 +0.998539521 +0.998685496 +0.998823804 +0.99895444 +0.999077404 +0.999192694 +0.999300306 +0.99940024 +0.999492493 +0.999577064 +0.999653951 +0.999723154 +0.99978467 +0.999838499 +0.99988464 +0.999923092 +0.999953855 +0.999976927 +0.999992309 +1 +1 +0.999992309 +0.999976927 +0.999953855 +0.999923092 +0.99988464 +0.999838499 +0.99978467 +0.999723154 +0.999653951 +0.999577064 +0.999492493 +0.99940024 +0.999300306 +0.999192694 +0.999077404 +0.99895444 +0.998823804 +0.998685496 +0.998539521 +0.99838588 +0.998224577 +0.998055614 +0.997878993 +0.997694719 +0.997502794 +0.997303221 +0.997096005 +0.996881148 +0.996658655 +0.99642853 +0.996190775 +0.995945396 +0.995692397 +0.995431782 +0.995163556 +0.994887724 +0.994604289 +0.994313258 +0.994014635 +0.993708426 +0.993394635 +0.993073269 +0.992744332 +0.992407831 +0.992063772 +0.99171216 +0.991353002 +0.990986303 +0.990612071 +0.990230311 +0.989841031 +0.989444238 +0.989039937 +0.988628136 +0.988208843 +0.987782064 +0.987347807 +0.98690608 +0.98645689 +0.986000245 +0.985536154 +0.985064623 +0.984585662 +0.984099278 +0.98360548 +0.983104277 +0.982595678 +0.98207969 +0.981556324 +0.981025588 +0.980487492 +0.979942044 +0.979389255 +0.978829133 +0.978261689 +0.977686933 +0.977104874 +0.976515523 +0.975918889 +0.975314984 +0.974703817 +0.974085399 +0.973459742 +0.972826855 +0.972186749 +0.971539437 +0.970884928 +0.970223235 +0.969554369 +0.968878341 +0.968195163 +0.967504847 +0.966807405 +0.966102849 +0.965391191 +0.964672443 +0.963946619 +0.963213729 +0.962473788 +0.961726807 +0.9609728 +0.96021178 +0.95944376 +0.958668753 +0.957886773 +0.957097832 +0.956301945 +0.955499126 +0.954689387 +0.953872744 +0.95304921 +0.9522188 +0.951381527 +0.950537406 +0.949686452 +0.948828679 +0.947964102 +0.947092736 +0.946214596 +0.945329697 +0.944438054 +0.943539683 +0.942634598 +0.941722817 +0.940804353 +0.939879223 +0.938947443 +0.938009029 +0.937063997 +0.936112362 +0.935154143 +0.934189353 +0.933218012 +0.932240134 +0.931255737 +0.930264837 +0.929267452 +0.928263598 +0.927253293 +0.926236555 +0.925213399 +0.924183844 +0.923147908 +0.922105608 +0.921056961 +0.920001986 +0.918940702 +0.917873124 +0.916799273 +0.915719167 +0.914632822 +0.91354026 +0.912441497 +0.911336552 +0.910225445 +0.909108193 +0.907984817 +0.906855336 +0.905719767 +0.904578131 +0.903430448 +0.902276736 +0.901117014 +0.899951304 +0.898779624 +0.897601995 +0.896418435 +0.895228966 +0.894033607 +0.892832379 +0.891625302 +0.890412396 +0.889193682 +0.887969181 +0.886738912 +0.885502897 +0.884261157 +0.883013712 +0.881760584 +0.880501793 +0.879237362 +0.87796731 +0.87669166 +0.875410433 +0.87412365 +0.872831333 +0.871533504 +0.870230185 +0.868921397 +0.867607162 +0.866287503 +0.864962441 +0.863631999 +0.862296199 +0.860955063 +0.859608613 +0.858256873 +0.856899864 +0.85553761 +0.854170133 +0.852797456 +0.851419602 +0.850036594 +0.848648454 +0.847255206 +0.845856874 +0.844453479 +0.843045047 +0.841631599 +0.84021316 +0.838789753 +0.837361402 +0.83592813 +0.834489961 +0.833046919 +0.831599028 +0.830146311 +0.828688793 +0.827226499 +0.825759451 +0.824287674 +0.822811193 +0.821330032 +0.819844215 +0.818353766 +0.816858711 +0.815359074 +0.813854879 +0.812346151 +0.810832916 +0.809315197 +0.80779302 +0.806266409 +0.80473539 +0.803199988 +0.801660228 +0.800116135 +0.798567734 +0.797015051 +0.79545811 +0.793896938 +0.79233156 +0.790762001 +0.789188287 +0.787610443 +0.786028495 +0.784442469 +0.782852391 +0.781258286 +0.77966018 +0.7780581 +0.77645207 +0.774842118 +0.773228269 +0.771610549 +0.769988984 +0.768363601 +0.766734425 +0.765101484 +0.763464803 +0.761824409 +0.760180327 +0.758532586 +0.75688121 +0.755226227 +0.753567663 +0.751905544 +0.750239898 +0.748570751 +0.746898129 +0.74522206 +0.74354257 +0.741859686 +0.740173435 +0.738483843 +0.736790938 +0.735094747 +0.733395296 +0.731692612 +0.729986724 +0.728277657 +0.726565438 +0.724850096 +0.723131656 +0.721410147 +0.719685595 +0.717958028 +0.716227472 +0.714493956 +0.712757506 +0.71101815 +0.709275916 +0.707530829 +0.705782919 +0.704032212 +0.702278736 +0.700522519 +0.698763587 +0.697001968 +0.69523769 +0.69347078 +0.691701267 +0.689929177 +0.688154537 +0.686377377 +0.684597723 +0.682815602 +0.681031044 +0.679244074 +0.677454722 +0.675663014 +0.673868978 +0.672072642 +0.670274034 +0.668473181 +0.666670112 +0.664864853 +0.663057433 +0.661247879 +0.65943622 +0.657622482 +0.655806695 +0.653988884 +0.652169079 +0.650347307 +0.648523596 +0.646697973 +0.644870467 +0.643041105 +0.641209915 +0.639376925 +0.637542163 +0.635705656 +0.633867432 +0.632027519 +0.630185944 +0.628342736 +0.626497923 +0.624651531 +0.62280359 +0.620954126 +0.619103167 +0.617250741 +0.615396876 +0.6135416 +0.61168494 +0.609826923 +0.607967579 +0.606106933 +0.604245015 +0.602381851 +0.60051747 +0.598651899 +0.596785165 +0.594917296 +0.59304832 +0.591178264 +0.589307156 +0.587435024 +0.585561895 +0.583687796 +0.581812755 +0.579936799 +0.578059956 +0.576182253 +0.574303719 +0.572424379 +0.570544261 +0.568663394 +0.566781803 +0.564899517 +0.563016563 +0.561132967 +0.559248758 +0.557363961 +0.555478606 +0.553592718 +0.551706324 +0.549819452 +0.54793213 +0.546044383 +0.544156239 +0.542267725 +0.540378867 +0.538489693 +0.53660023 +0.534710504 +0.532820543 +0.530930372 +0.529040019 +0.52714951 +0.525258872 +0.523368132 +0.521477316 +0.519586451 +0.517695564 +0.51580468 +0.513913826 +0.512023029 +0.510132315 +0.508241711 +0.506351241 +0.504460934 +0.502570815 +0.50068091 +0.498791245 +0.496901847 +0.495012741 +0.493123953 +0.491235509 +0.489347436 +0.487459759 +0.485572503 +0.483685696 +0.481799361 +0.479913525 +0.478028214 +0.476143453 +0.474259267 +0.472375683 +0.470492725 +0.468610418 +0.466728789 +0.464847862 +0.462967663 +0.461088216 +0.459209547 +0.457331681 +0.455454643 +0.453578457 +0.451703149 +0.449828743 +0.447955265 +0.446082738 +0.444211188 +0.442340638 +0.440471115 +0.438602641 +0.436735242 +0.434868942 +0.433003765 +0.431139736 +0.429276878 +0.427415215 +0.425554772 +0.423695573 +0.421837641 +0.419981001 +0.418125676 +0.41627169 +0.414419067 +0.41256783 +0.410718003 +0.408869609 +0.407022671 +0.405177213 +0.403333259 +0.401490831 +0.399649953 +0.397810647 +0.395972937 +0.394136845 +0.392302395 +0.390469609 +0.38863851 +0.38680912 +0.384981463 +0.38315556 +0.381331434 +0.379509107 +0.377688602 +0.375869941 +0.374053146 +0.372238239 +0.370425242 +0.368614177 +0.366805066 +0.364997931 +0.363192793 +0.361389673 +0.359588594 +0.357789577 +0.355992643 +0.354197813 +0.352405109 +0.350614553 +0.348826164 +0.347039964 +0.345255973 +0.343474214 +0.341694706 +0.33991747 +0.338142526 +0.336369896 +0.334599599 +0.332831656 +0.331066087 +0.329302913 +0.327542153 +0.325783827 +0.324027956 +0.322274559 +0.320523656 +0.318775266 +0.31702941 +0.315286106 +0.313545374 +0.311807234 +0.310071705 +0.308338805 +0.306608554 +0.304880971 +0.303156074 +0.301433884 +0.299714417 +0.297997693 +0.296283731 +0.294572549 +0.292864165 +0.291158597 +0.289455865 +0.287755984 +0.286058975 +0.284364855 +0.282673641 +0.280985351 +0.279300003 +0.277617615 +0.275938203 +0.274261786 +0.272588381 +0.270918004 +0.269250673 +0.267586404 +0.265925216 +0.264267124 +0.262612145 +0.260960296 +0.259311593 +0.257666054 +0.256023693 +0.254384528 +0.252748574 +0.251115848 +0.249486366 +0.247860143 +0.246237195 +0.244617538 +0.243001188 +0.241388159 +0.239778468 +0.238172129 +0.236569158 +0.23496957 +0.23337338 +0.231780602 +0.230191252 +0.228605345 +0.227022894 +0.225443915 +0.223868421 +0.222296427 +0.220727948 +0.219162997 +0.217601589 +0.216043737 +0.214489455 +0.212938757 +0.211391657 +0.209848167 +0.208308302 +0.206772075 +0.205239498 +0.203710586 +0.202185351 +0.200663805 +0.199145963 +0.197631836 +0.196121437 +0.194614779 +0.193111874 +0.191612735 +0.190117373 +0.188625801 +0.18713803 +0.185654073 +0.184173942 +0.182697648 +0.181225202 +0.179756617 +0.178291903 +0.176831072 +0.175374136 +0.173921105 +0.17247199 +0.171026802 +0.169585552 +0.16814825 +0.166714908 +0.165285535 +0.163860143 +0.162438741 +0.161021339 +0.159607948 +0.158198577 +0.156793237 +0.155391937 +0.153994686 +0.152601495 +0.151212373 +0.149827329 +0.148446373 +0.147069513 +0.145696758 +0.144328118 +0.142963602 +0.141603218 +0.140246974 +0.13889488 +0.137546943 +0.136203173 +0.134863577 +0.133528163 +0.132196939 +0.130869914 +0.129547095 +0.12822849 +0.126914106 +0.125603951 +0.124298032 +0.122996357 +0.121698933 +0.120405767 +0.119116866 +0.117832236 +0.116551885 +0.115275819 +0.114004045 +0.112736569 +0.111473398 +0.110214538 +0.108959995 +0.107709775 +0.106463884 +0.105222329 +0.103985114 +0.102752245 +0.101523729 +0.100299569 +0.0990797731 +0.0978643447 +0.0966532896 +0.0954466127 +0.094244319 +0.0930464133 +0.0918529004 +0.0906637849 +0.0894790714 +0.0882987643 +0.087122868 +0.0859513867 +0.0847843245 +0.0836216855 +0.0824634736 +0.0813096928 +0.0801603466 +0.0790154388 +0.0778749729 +0.0767389523 +0.0756073804 +0.0744802605 +0.0733575956 +0.0722393889 +0.0711256432 +0.0700163614 +0.0689115463 +0.0678112006 +0.0667153267 +0.0656239271 +0.0645370042 +0.0634545603 +0.0623765975 +0.0613031178 +0.0602341233 +0.0591696158 +0.0581095971 +0.0570540688 +0.0560030326 +0.0549564899 +0.0539144421 +0.0528768905 +0.0518438363 +0.0508152805 +0.0497912243 +0.0487716685 +0.0477566139 +0.0467460612 +0.045740011 +0.044738464 +0.0437414205 +0.0427488808 +0.0417608452 +0.0407773139 +0.0397982869 +0.0388237642 +0.0378537456 +0.036888231 +0.0359272199 +0.0349707121 +0.034018707 +0.033071204 +0.0321282025 +0.0311897016 +0.0302557006 +0.0293261983 +0.0284011939 +0.0274806861 +0.0265646738 +0.0256531556 +0.0247461301 +0.0238435958 +0.0229455511 +0.0220519944 +0.0211629238 +0.0202783376 +0.0193982338 +0.0185226103 +0.0176514651 +0.0167847959 +0.0159226004 +0.0150648763 +0.0142116211 +0.0133628323 +0.0125185071 +0.0116786429 +0.0108432369 +0.0100122861 +0.00918578767 +0.00836373842 +0.00754613524 +0.00673297489 +0.00592425405 +0.00511996931 +0.0043201172 +0.00352469414 +0.00273369648 +0.00194712048 +0.00116496233 +0.000387218116 +0.00038611613 +0.00115504448 +0.00191957106 +0.00267970012 +0.00343543595 +0.00418678294 +0.00493374555 +0.00567632833 +0.00641453591 +0.00714837297 +0.00787784432 +0.0086029548 +0.00932370935 +0.010040113 +0.0107521708 +0.011459888 +0.0121632698 +0.0128623215 +0.0135570485 +0.0142474563 +0.0149335504 +0.0156153365 +0.0162928203 +0.0169660075 +0.0176349041 +0.0182995158 +0.0189598487 +0.0196159089 +0.0202677025 +0.0209152357 +0.0215585148 +0.0221975462 +0.0228323363 +0.0234628916 +0.0240892186 +0.024711324 +0.0253292145 +0.0259428969 +0.0265523781 +0.0271576649 +0.0277587643 +0.0283556834 +0.0289484293 +0.0295370092 +0.0301214303 +0.0307017 +0.0312778257 +0.0318498147 +0.0324176747 +0.0329814132 +0.0335410379 +0.0340965564 +0.0346479766 +0.0351953062 +0.0357385533 +0.0362777257 +0.0368128315 +0.0373438788 +0.0378708757 +0.0383938305 +0.0389127514 +0.0394276467 +0.0399385249 +0.0404453944 +0.0409482637 +0.0414471415 +0.0419420363 +0.0424329568 +0.0429199118 +0.04340291 +0.0438819605 +0.044357072 +0.0448282535 +0.0452955141 +0.0457588629 +0.046218309 +0.0466738617 +0.0471255301 +0.0475733235 +0.0480172514 +0.0484573232 +0.0488935483 +0.0493259362 +0.0497544965 +0.0501792389 +0.050600173 +0.0510173085 +0.0514306552 +0.0518402229 +0.0522460216 +0.0526480611 +0.0530463514 +0.0534409025 +0.0538317245 +0.0542188276 +0.0546022218 +0.0549819174 +0.0553579247 +0.0557302539 +0.0560989154 +0.0564639196 +0.056825277 +0.057182998 +0.0575370931 +0.0578875729 +0.0582344481 +0.0585777293 +0.0589174271 +0.0592535524 +0.0595861158 +0.0599151284 +0.0602406008 +0.060562544 +0.0608809689 +0.0611958866 +0.061507308 +0.0618152443 +0.0621197064 +0.0624207056 +0.062718253 +0.0630123599 +0.0633030374 +0.0635902969 +0.0638741496 +0.064154607 +0.0644316804 +0.0647053813 +0.0649757211 +0.0652427112 +0.0655063633 +0.0657666889 +0.0660236995 +0.0662774069 +0.0665278225 +0.0667749582 +0.0670188257 +0.0672594366 +0.0674968028 +0.067730936 +0.0679618482 +0.0681895511 +0.0684140566 +0.0686353768 +0.0688535234 +0.0690685085 +0.0692803441 +0.0694890423 +0.069694615 +0.0698970743 +0.0700964323 +0.0702927013 +0.0704858932 +0.0706760203 +0.0708630948 +0.0710471289 +0.0712281348 +0.0714061249 +0.0715811113 +0.0717531065 +0.0719221226 +0.0720881722 +0.0722512674 +0.0724114208 +0.0725686447 +0.0727229516 +0.0728743539 +0.0730228641 +0.0731684945 +0.0733112578 +0.0734511665 +0.073588233 +0.07372247 +0.0738538899 +0.0739825054 +0.074108329 +0.0742313734 +0.0743516512 +0.0744691749 +0.0745839573 +0.0746960109 +0.0748053486 +0.0749119829 +0.0750159265 +0.0751171921 +0.0752157926 +0.0753117405 +0.0754050486 +0.0754957297 +0.0755837964 +0.0756692617 +0.0757521382 +0.0758324387 +0.075910176 +0.0759853629 +0.0760580122 +0.0761281368 +0.0761957493 +0.0762608626 +0.0763234896 +0.0763836431 +0.0764413358 +0.0764965808 +0.0765493907 +0.0765997784 +0.0766477567 +0.0766933386 +0.0767365369 +0.0767773643 +0.0768158339 +0.0768519583 +0.0768857505 +0.0769172233 +0.0769463896 +0.0769732623 +0.0769978541 +0.0770201779 +0.0770402467 +0.0770580731 +0.0770736701 +0.0770870506 +0.0770982273 +0.077107213 +0.0771140207 +0.0771186631 +0.0771211531 +0.0771215035 +0.0771197271 +0.0771158367 +0.0771098451 +0.077101765 +0.0770916094 +0.0770793909 +0.0770651223 +0.0770488165 +0.077030486 +0.0770101438 +0.0769878026 +0.076963475 +0.0769371737 +0.0769089116 +0.0768787013 +0.0768465554 +0.0768124868 +0.0767765079 +0.0767386316 +0.0766988703 +0.0766572368 +0.0766137437 +0.0765684036 +0.076521229 +0.0764722326 +0.0764214269 +0.0763688245 +0.0763144379 +0.0762582795 +0.076200362 +0.0761406979 +0.0760792995 +0.0760161793 +0.0759513498 +0.0758848234 +0.0758166125 +0.0757467295 +0.0756751868 +0.0756019967 +0.0755271716 +0.0754507237 +0.0753726654 +0.0752930089 +0.0752117665 +0.0751289505 +0.075044573 +0.0749586462 +0.0748711824 +0.0747821936 +0.074691692 +0.0745996898 +0.0745061989 +0.0744112315 +0.0743147997 +0.0742169153 +0.0741175905 +0.0740168372 +0.0739146673 +0.0738110928 +0.0737061255 +0.0735997774 +0.0734920604 +0.0733829861 +0.0732725665 +0.0731608132 +0.0730477381 +0.0729333529 +0.0728176692 +0.0727006988 +0.0725824532 +0.0724629442 +0.0723421832 +0.0722201818 +0.0720969516 +0.071972504 +0.0718468506 +0.0717200028 +0.0715919719 +0.0714627694 +0.0713324067 +0.071200895 +0.0710682457 +0.07093447 +0.0707995792 +0.0706635844 +0.0705264968 +0.0703883276 +0.0702490879 +0.0701087887 +0.0699674411 +0.0698250561 +0.0696816448 +0.0695372179 +0.0693917866 +0.0692453615 +0.0690979537 +0.0689495738 +0.0688002327 +0.0686499411 +0.0684987098 +0.0683465494 +0.0681934705 +0.0680394838 +0.0678845998 +0.0677288291 +0.0675721821 +0.0674146694 +0.0672563014 +0.0670970884 +0.0669370408 +0.066776169 +0.0666144832 +0.0664519936 +0.0662887106 +0.0661246441 +0.0659598045 +0.0657942017 +0.0656278459 +0.0654607471 +0.0652929152 +0.0651243601 +0.0649550919 +0.0647851204 +0.0646144553 +0.0644431065 +0.0642710837 +0.0640983967 +0.0639250551 +0.0637510686 +0.0635764466 +0.0634011989 +0.0632253349 +0.063048864 +0.0628717957 +0.0626941395 +0.0625159045 +0.0623371003 +0.0621577359 +0.0619778207 +0.0617973638 +0.0616163743 +0.0614348615 +0.0612528342 +0.0610703017 +0.0608872727 +0.0607037563 +0.0605197613 +0.0603352967 +0.0601503711 +0.0599649935 +0.0597791724 +0.0595929165 +0.0594062346 +0.0592191352 +0.0590316268 +0.0588437179 +0.0586554171 +0.0584667326 +0.058277673 +0.0580882466 +0.0578984615 +0.0577083261 +0.0575178486 +0.057327037 +0.0571358996 +0.0569444444 +0.0567526794 +0.0565606126 +0.056368252 +0.0561756053 +0.0559826805 +0.0557894854 +0.0555960276 +0.055402315 +0.0552083552 +0.0550141557 +0.0548197242 +0.0546250683 +0.0544301953 +0.0542351127 +0.054039828 +0.0538443484 +0.0536486812 +0.0534528338 +0.0532568133 +0.0530606269 +0.0528642817 +0.0526677847 +0.0524711431 +0.0522743638 +0.0520774536 +0.0518804196 +0.0516832685 +0.0514860072 +0.0512886424 +0.0510911807 +0.0508936289 +0.0506959936 +0.0504982813 +0.0503004986 +0.0501026519 +0.0499047476 +0.0497067922 +0.0495087919 +0.0493107531 +0.0491126819 +0.0489145847 +0.0487164674 +0.0485183364 +0.0483201975 +0.0481220568 +0.0479239202 +0.0477257938 +0.0475276832 +0.0473295945 +0.0471315333 +0.0469335053 +0.0467355163 +0.0465375719 +0.0463396777 +0.0461418393 +0.045944062 +0.0457463514 +0.0455487129 +0.0453511519 +0.0451536736 +0.0449562833 +0.0447589862 +0.0445617876 +0.0443646925 +0.044167706 +0.0439708332 +0.043774079 +0.0435774484 +0.0433809463 +0.0431845775 +0.0429883469 +0.0427922591 +0.042596319 +0.0424005311 +0.0422049002 +0.0420094306 +0.0418141271 +0.0416189941 +0.041424036 +0.0412292572 +0.0410346621 +0.0408402549 +0.04064604 +0.0404520215 +0.0402582036 +0.0400645904 +0.0398711859 +0.0396779943 +0.0394850196 +0.0392922655 +0.0390997361 +0.0389074352 +0.0387153666 +0.038523534 +0.0383319412 +0.0381405919 +0.0379494896 +0.037758638 +0.0375680406 +0.0373777009 +0.0371876223 +0.0369978083 +0.0368082622 +0.0366189873 +0.036429987 +0.0362412643 +0.0360528226 +0.035864665 +0.0356767946 +0.0354892144 +0.0353019274 +0.0351149367 +0.0349282451 +0.0347418555 +0.0345557709 +0.0343699939 +0.0341845274 +0.033999374 +0.0338145364 +0.0336300174 +0.0334458194 +0.033261945 +0.0330783967 +0.032895177 +0.0327122883 +0.032529733 +0.0323475134 +0.0321656318 +0.0319840905 +0.0318028918 +0.0316220377 +0.0314415304 +0.0312613721 +0.0310815647 +0.0309021103 +0.0307230109 +0.0305442683 +0.0303658846 +0.0301878615 +0.0300102009 +0.0298329045 +0.0296559741 +0.0294794114 +0.029303218 +0.0291273956 +0.0289519457 +0.0287768699 +0.0286021697 +0.0284278466 +0.028253902 +0.0280803372 +0.0279071537 +0.0277343527 +0.0275619356 +0.0273899036 +0.0272182578 +0.0270469995 +0.0268761297 +0.0267056496 +0.0265355603 +0.0263658627 +0.0261965579 +0.0260276467 +0.0258591301 +0.025691009 +0.0255232843 +0.0253559566 +0.0251890269 +0.0250224958 +0.0248563641 +0.0246906323 +0.0245253012 +0.0243603714 +0.0241958433 +0.0240317176 +0.0238679948 +0.0237046752 +0.0235417594 +0.0233792478 +0.0232171406 +0.0230554382 +0.022894141 +0.0227332492 +0.0225727631 +0.0224126827 +0.0222530084 +0.0220937403 +0.0219348784 +0.0217764228 +0.0216183736 +0.0214607308 +0.0213034945 +0.0211466644 +0.0209902406 +0.020834223 +0.0206786114 +0.0205234057 +0.0203686056 +0.020214211 +0.0200602216 +0.019906637 +0.0197534571 +0.0196006814 +0.0194483097 +0.0192963414 +0.0191447761 +0.0189936136 +0.0188428531 +0.0186924943 +0.0185425366 +0.0183929794 +0.0182438222 +0.0180950644 +0.0179467052 +0.0177987441 +0.0176511804 +0.0175040133 +0.0173572421 +0.0172108661 +0.0170648843 +0.0169192962 +0.0167741007 +0.016629297 +0.0164848842 +0.0163408615 +0.0161972279 +0.0160539824 +0.015911124 +0.0157686518 +0.0156265647 +0.0154848617 +0.0153435416 +0.0152026035 +0.0150620461 +0.0149218683 +0.0147820691 +0.0146426471 +0.0145036012 +0.0143649302 +0.0142266329 +0.0140887078 +0.0139511539 +0.0138139698 +0.013677154 +0.0135407055 +0.0134046226 +0.0132689041 +0.0131335486 +0.0129985546 +0.0128639208 +0.0127296456 +0.0125957275 +0.0124621652 +0.012328957 +0.0121961015 +0.0120635972 +0.0119314423 +0.0117996355 +0.011668175 +0.0115370594 +0.0114062868 +0.0112758559 +0.0111457647 +0.0110160118 +0.0108865953 +0.0107575137 +0.0106287652 +0.010500348 +0.0103722605 +0.0102445008 +0.0101170672 +0.00998995796 +0.00986317122 +0.00973670518 +0.00961055802 +0.00948472792 +0.00935921303 +0.00923401147 +0.0091091214 +0.00898454092 +0.00886026813 +0.00873630115 +0.00861263804 +0.00848927689 +0.00836621575 +0.00824345268 +0.00812098573 +0.00799881293 +0.00787693229 +0.00775534184 +0.00763403959 +0.00751302352 +0.00739229163 +0.00727184189 +0.00715167228 +0.00703178077 +0.0069121653 +0.00679282382 +0.00667375429 +0.00655495462 +0.00643642275 +0.0063181566 +0.00620015408 +0.0060824131 +0.00596493156 +0.00584770736 +0.00573073839 +0.00561402253 +0.00549755767 +0.00538134167 +0.00526537242 +0.00514964778 +0.0050341656 +0.00491892375 +0.00480392009 +0.00468915245 +0.0045746187 +0.00446031667 +0.00434624421 +0.00423239915 +0.00411877934 +0.0040053826 +0.00389220677 +0.00377924967 +0.00366650915 +0.00355398301 +0.0034416691 +0.00332956523 +0.00321766924 +0.00310597893 +0.00299449215 +0.0028832067 +0.00277212042 +0.00266123112 +0.00255053664 +0.00244003479 +0.00232972341 +0.00221960031 +0.00210966333 +0.0019999103 +0.00189033905 +0.00178094741 +0.00167173322 +0.00156269432 +0.00145382854 +0.00134513373 +0.00123660773 +0.0011282484 +0.00102005359 +0.000912021157 +0.000804148955 +0.00069643485 +0.000588876712 +0.000481472412 +0.000374219827 +0.000267116839 +0.000160161335 +5.33512061e-05 + +shape_id 2 +num_samples 3000 +0.5 +0 +0 +747 +-0.5 +0 +0 +1497 +0.5 +0 +0 +747 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash 9e740ddd2bba2cccf648c5d3705f9fa1 diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-pulse.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-pulse.mat new file mode 100644 index 000000000..c71194aca Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-pulse.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-pulse.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-pulse.seq new file mode 100644 index 000000000..4abf1cff6 --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-pulse.seq @@ -0,0 +1,53 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name rf-pulse +RadiofrequencyRasterTime 1e-06 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] +1 1000 1 0 0 0 0 0 +2 1000 1 0 0 0 0 0 +3 1000 1 0 0 0 0 0 + +# Format of RF events: +# id amplitude mag_id phase_id time_shape_id delay freq phase +# .. Hz .... .... .... us Hz rad +[RF] +1 25 1 2 3 0 0 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 2 +1 +1 + +shape_id 2 +num_samples 2 +0 +0 + +shape_id 3 +num_samples 2 +0 +10000 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash 9dba59a47bb2ee82e84faf1272a75298 diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-time-shaped.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-time-shaped.mat new file mode 100644 index 000000000..621921e3c Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-time-shaped.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-time-shaped.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-time-shaped.seq new file mode 100644 index 000000000..60cdaefab --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-time-shaped.seq @@ -0,0 +1,53 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name rf-time-shaped +RadiofrequencyRasterTime 1e-06 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] +1 10 1 0 0 0 0 0 +2 10 1 0 0 0 0 0 +3 10 1 0 0 0 0 0 + +# Format of RF events: +# id amplitude mag_id phase_id time_shape_id delay freq phase +# .. Hz .... .... .... us Hz rad +[RF] +1 2500 1 2 3 0 0 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 2 +1 +1 + +shape_id 2 +num_samples 2 +0 +0 + +shape_id 3 +num_samples 2 +0 +100 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash 9124e9cd832710dfb0421cfeb7d1d7bb diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-uniformly-shaped.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-uniformly-shaped.mat new file mode 100644 index 000000000..99b47651e Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-uniformly-shaped.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-uniformly-shaped.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-uniformly-shaped.seq new file mode 100644 index 000000000..8b10bea9a --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/rf-uniformly-shaped.seq @@ -0,0 +1,62 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +GradientRasterTime 1e-05 +Name rf-uniformly-shaped +RadiofrequencyRasterTime 1e-06 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] +1 1 1 0 0 0 0 0 +2 1 1 0 0 0 0 0 +3 1 1 0 0 0 0 0 + +# Format of RF events: +# id amplitude mag_id phase_id time_shape_id delay freq phase +# .. Hz .... .... .... us Hz rad +[RF] +1 104420 1 2 0 0 0 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 10 +0.111111111 +0.231147713 +4.16698716e-17 +0.539344663 +1 +1 +0.539344663 +6.46093624e-16 +0.231147713 +0.111111111 + +shape_id 2 +num_samples 10 +0.5 +0 +-0.5 +0 +0 +3 +0.5 +0 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash b920c7d3023f212dd64ca7d87f6ab1eb diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/spiral.mat b/KomaMRIFiles/test/test_files/pulseq_read_comparison/spiral.mat new file mode 100644 index 000000000..57c0fb5aa Binary files /dev/null and b/KomaMRIFiles/test/test_files/pulseq_read_comparison/spiral.mat differ diff --git a/KomaMRIFiles/test/test_files/pulseq_read_comparison/spiral.seq b/KomaMRIFiles/test/test_files/pulseq_read_comparison/spiral.seq new file mode 100644 index 000000000..b54966e0b --- /dev/null +++ b/KomaMRIFiles/test/test_files/pulseq_read_comparison/spiral.seq @@ -0,0 +1,19063 @@ +# Pulseq sequence file +# Created by MATLAB mr toolbox + +[VERSION] +major 1 +minor 4 +revision 1 + +[DEFINITIONS] +AdcRasterTime 1e-07 +BlockDurationRaster 1e-05 +FOV 0.256 0.256 0.003 +GradientRasterTime 1e-05 +MaxAdcSegmentLength 1000 +Name spiral +RadiofrequencyRasterTime 1e-06 +TotalDuration 0.06138 + +# Format of blocks: +# NUM DUR RF GX GY GZ ADC EXT +[BLOCKS] +1 1621 1 0 0 1 0 0 +2 319 2 0 0 2 0 0 +3 4055 0 4 5 3 1 0 +4 143 0 7 8 6 0 0 + +# Format of RF events: +# id amplitude mag_id phase_id time_shape_id delay freq phase +# .. Hz .... .... .... us Hz rad +[RF] +1 129.712 1 2 0 100 -424.504 0 +2 329.152 3 4 0 100 0 0 + +# Format of arbitrary gradients: +# time_shape_id of 0 means default timing (stepping with grad_raster starting at 1/2 of grad_raster) +# id amplitude amp_shape_id time_shape_id delay +# .. Hz/m .. .. us +[GRADIENTS] +4 -947610 5 0 790 +5 946371 6 0 790 +7 -947610 7 8 0 +8 46816.9 7 8 0 + +# Format of trapezoid gradients: +# id amplitude rise flat fall delay +# .. Hz/m us us us us +[TRAP] + 1 1.27714e+06 250 7580 250 8130 + 2 444444 90 3000 90 10 + 3 -1.2716e+06 250 290 250 0 + 6 1.27119e+06 250 930 250 0 + +# Format of ADC events: +# id num dwell delay freq phase +# .. .. ns us Hz rad +[ADC] +1 28000 1400 790 0 0 + +# Sequence Shapes +[SHAPES] + +shape_id 1 +num_samples 8000 +0.00011671692 +0.000117246598 +0.000117778547 +0.000118312775 +0.000118849292 +0.000119388107 +0.000119929229 +0.000120472667 +0.00012101843 +0.000121566528 +0.00012211697 +0.000122669766 +0.000123224925 +0.000123782455 +0.000124342368 +0.000124904672 +0.000125469377 +0.000126036492 +0.000126606027 +0.000127177991 +0.000127752395 +0.000128329248 +0.00012890856 +0.00012949034 +0.000130074599 +0.000130661345 +0.00013125059 +0.000131842343 +0.000132436615 +0.000133033414 +0.000133632751 +0.000134234636 +0.000134839079 +0.000135446091 +0.000136055681 +0.000136667861 +0.000137282639 +0.000137900026 +0.000138520034 +0.000139142671 +0.000139767949 +0.000140395877 +0.000141026467 +0.000141659729 +0.000142295674 +0.000142934311 +0.000143575652 +0.000144219708 +0.000144866489 +0.000145516005 +0.000146168268 +0.000146823289 +0.000147481078 +0.000148141646 +0.000148805005 +0.000149471164 +0.000150140136 +0.000150811931 +0.000151486561 +0.000152164036 +0.000152844368 +0.000153527567 +0.000154213646 +0.000154902616 +0.000155594487 +0.000156289272 +0.000156986981 +0.000157687627 +0.00015839122 +0.000159097773 +0.000159807296 +0.000160519802 +0.000161235302 +0.000161953808 +0.000162675332 +0.000163399885 +0.000164127479 +0.000164858127 +0.000165591839 +0.000166328629 +0.000167068508 +0.000167811488 +0.000168557582 +0.000169306801 +0.000170059157 +0.000170814664 +0.000171573332 +0.000172335175 +0.000173100205 +0.000173868435 +0.000174639875 +0.00017541454 +0.000176192442 +0.000176973594 +0.000177758007 +0.000178545694 +0.00017933667 +0.000180130945 +0.000180928533 +0.000181729447 +0.0001825337 +0.000183341305 +0.000184152274 +0.000184966621 +0.000185784359 +0.0001866055 +0.000187430059 +0.000188258048 +0.000189089481 +0.00018992437 +0.00019076273 +0.000191604574 +0.000192449915 +0.000193298766 +0.000194151142 +0.000195007056 +0.000195866521 +0.000196729551 +0.000197596161 +0.000198466363 +0.000199340172 +0.000200217601 +0.000201098665 +0.000201983377 +0.000202871752 +0.000203763803 +0.000204659545 +0.000205558992 +0.000206462158 +0.000207369058 +0.000208279705 +0.000209194114 +0.000210112301 +0.000211034278 +0.000211960061 +0.000212889664 +0.000213823102 +0.00021476039 +0.000215701542 +0.000216646573 +0.000217595498 +0.000218548332 +0.00021950509 +0.000220465787 +0.000221430438 +0.000222399058 +0.000223371661 +0.000224348265 +0.000225328883 +0.000226313531 +0.000227302224 +0.000228294978 +0.000229291809 +0.000230292731 +0.000231297761 +0.000232306914 +0.000233320205 +0.000234337651 +0.000235359268 +0.00023638507 +0.000237415075 +0.000238449298 +0.000239487755 +0.000240530462 +0.000241577435 +0.000242628691 +0.000243684245 +0.000244744115 +0.000245808316 +0.000246876865 +0.000247949779 +0.000249027073 +0.000250108764 +0.00025119487 +0.000252285407 +0.000253380391 +0.000254479839 +0.000255583769 +0.000256692197 +0.00025780514 +0.000258922615 +0.00026004464 +0.000261171231 +0.000262302406 +0.000263438182 +0.000264578576 +0.000265723606 +0.000266873289 +0.000268027644 +0.000269186686 +0.000270350434 +0.000271518906 +0.00027269212 +0.000273870093 +0.000275052843 +0.000276240388 +0.000277432746 +0.000278629935 +0.000279831974 +0.00028103888 +0.000282250672 +0.000283467369 +0.000284688987 +0.000285915547 +0.000287147065 +0.000288383562 +0.000289625056 +0.000290871565 +0.000292123107 +0.000293379703 +0.00029464137 +0.000295908129 +0.000297179997 +0.000298456993 +0.000299739138 +0.00030102645 +0.000302318948 +0.000303616652 +0.000304919581 +0.000306227754 +0.000307541192 +0.000308859914 +0.000310183939 +0.000311513287 +0.000312847978 +0.000314188031 +0.000315533468 +0.000316884307 +0.000318240569 +0.000319602274 +0.000320969442 +0.000322342094 +0.000323720249 +0.000325103928 +0.000326493152 +0.000327887941 +0.000329288316 +0.000330694297 +0.000332105906 +0.000333523162 +0.000334946087 +0.000336374702 +0.000337809028 +0.000339249086 +0.000340694897 +0.000342146483 +0.000343603864 +0.000345067062 +0.000346536098 +0.000348010995 +0.000349491773 +0.000350978455 +0.000352471061 +0.000353969614 +0.000355474136 +0.000356984649 +0.000358501175 +0.000360023735 +0.000361552352 +0.000363087048 +0.000364627846 +0.000366174768 +0.000367727836 +0.000369287073 +0.000370852502 +0.000372424145 +0.000374002025 +0.000375586165 +0.000377176588 +0.000378773316 +0.000380376374 +0.000381985783 +0.000383601568 +0.000385223751 +0.000386852356 +0.000388487407 +0.000390128926 +0.000391776938 +0.000393431466 +0.000395092534 +0.000396760165 +0.000398434385 +0.000400115216 +0.000401802683 +0.00040349681 +0.000405197621 +0.000406905141 +0.000408619393 +0.000410340403 +0.000412068195 +0.000413802794 +0.000415544223 +0.000417292509 +0.000419047676 +0.000420809748 +0.000422578752 +0.000424354712 +0.000426137653 +0.0004279276 +0.00042972458 +0.000431528616 +0.000433339736 +0.000435157964 +0.000436983327 +0.000438815849 +0.000440655558 +0.000442502478 +0.000444356636 +0.000446218058 +0.000448086771 +0.0004499628 +0.000451846171 +0.000453736912 +0.000455635049 +0.000457540609 +0.000459453617 +0.000461374102 +0.000463302089 +0.000465237607 +0.000467180681 +0.00046913134 +0.00047108961 +0.000473055518 +0.000475029093 +0.000477010361 +0.000478999351 +0.000480996089 +0.000483000604 +0.000485012924 +0.000487033076 +0.000489061088 +0.000491096989 +0.000493140807 +0.00049519257 +0.000497252307 +0.000499320045 +0.000501395815 +0.000503479643 +0.00050557156 +0.000507671594 +0.000509779773 +0.000511896128 +0.000514020686 +0.000516153478 +0.000518294532 +0.000520443879 +0.000522601547 +0.000524767566 +0.000526941966 +0.000529124776 +0.000531316027 +0.000533515749 +0.000535723971 +0.000537940724 +0.000540166038 +0.000542399943 +0.00054464247 +0.00054689365 +0.000549153512 +0.000551422088 +0.00055369941 +0.000555985506 +0.000558280409 +0.000560584151 +0.000562896761 +0.000565218271 +0.000567548713 +0.000569888119 +0.00057223652 +0.000574593947 +0.000576960433 +0.00057933601 +0.000581720709 +0.000584114562 +0.000586517603 +0.000588929863 +0.000591351374 +0.00059378217 +0.000596222283 +0.000598671745 +0.00060113059 +0.00060359885 +0.000606076559 +0.00060856375 +0.000611060455 +0.000613566709 +0.000616082544 +0.000618607995 +0.000621143095 +0.000623687878 +0.000626242378 +0.000628806628 +0.000631380663 +0.000633964518 +0.000636558225 +0.000639161821 +0.000641775339 +0.000644398813 +0.00064703228 +0.000649675773 +0.000652329328 +0.000654992979 +0.000657666762 +0.000660350713 +0.000663044866 +0.000665749256 +0.000668463921 +0.000671188895 +0.000673924214 +0.000676669914 +0.000679426032 +0.000682192603 +0.000684969663 +0.00068775725 +0.000690555399 +0.000693364148 +0.000696183533 +0.00069901359 +0.000701854357 +0.000704705871 +0.000707568169 +0.000710441289 +0.000713325267 +0.000716220142 +0.000719125951 +0.000722042731 +0.000724970521 +0.000727909359 +0.000730859282 +0.000733820329 +0.000736792539 +0.00073977595 +0.0007427706 +0.000745776528 +0.000748793772 +0.000751822373 +0.000754862369 +0.000757913798 +0.000760976702 +0.000764051117 +0.000767137086 +0.000770234646 +0.000773343838 +0.000776464701 +0.000779597277 +0.000782741604 +0.000785897723 +0.000789065675 +0.000792245499 +0.000795437238 +0.00079864093 +0.000801856618 +0.000805084342 +0.000808324144 +0.000811576064 +0.000814840144 +0.000818116426 +0.000821404951 +0.00082470576 +0.000828018897 +0.000831344402 +0.000834682318 +0.000838032687 +0.000841395552 +0.000844770954 +0.000848158938 +0.000851559545 +0.000854972818 +0.0008583988 +0.000861837535 +0.000865289066 +0.000868753436 +0.000872230689 +0.000875720869 +0.000879224018 +0.000882740182 +0.000886269404 +0.000889811728 +0.000893367199 +0.000896935862 +0.00090051776 +0.000904112939 +0.000907721443 +0.000911343318 +0.000914978608 +0.000918627359 +0.000922289616 +0.000925965425 +0.000929654832 +0.000933357881 +0.00093707462 +0.000940805094 +0.00094454935 +0.000948307433 +0.000952079391 +0.00095586527 +0.000959665116 +0.000963478977 +0.0009673069 +0.000971148931 +0.000975005119 +0.00097887551 +0.000982760152 +0.000986659094 +0.000990572382 +0.000994500065 +0.000998442191 +0.00100239881 +0.00100636997 +0.00101035571 +0.00101435609 +0.00101837116 +0.00102240097 +0.00102644555 +0.00103050498 +0.00103457928 +0.00103866852 +0.00104277274 +0.00104689199 +0.00105102632 +0.00105517579 +0.00105934043 +0.00106352032 +0.00106771548 +0.00107192598 +0.00107615187 +0.00108039319 +0.00108465 +0.00108892235 +0.00109321029 +0.00109751387 +0.00110183315 +0.00110616817 +0.00111051899 +0.00111488566 +0.00111926823 +0.00112366676 +0.0011280813 +0.0011325119 +0.00113695861 +0.00114142149 +0.00114590059 +0.00115039596 +0.00115490767 +0.00115943575 +0.00116398027 +0.00116854128 +0.00117311883 +0.00117771298 +0.00118232379 +0.0011869513 +0.00119159557 +0.00119625666 +0.00120093463 +0.00120562952 +0.00121034139 +0.00121507031 +0.00121981632 +0.00122457948 +0.00122935985 +0.00123415748 +0.00123897244 +0.00124380477 +0.00124865453 +0.00125352178 +0.00125840658 +0.00126330899 +0.00126822906 +0.00127316685 +0.00127812241 +0.00128309582 +0.00128808711 +0.00129309636 +0.00129812362 +0.00130316895 +0.00130823241 +0.00131331405 +0.00131841394 +0.00132353214 +0.0013286687 +0.00133382368 +0.00133899715 +0.00134418917 +0.00134939978 +0.00135462907 +0.00135987707 +0.00136514387 +0.00137042951 +0.00137573405 +0.00138105757 +0.00138640012 +0.00139176175 +0.00139714255 +0.00140254255 +0.00140796183 +0.00141340046 +0.00141885848 +0.00142433597 +0.00142983298 +0.00143534959 +0.00144088585 +0.00144644182 +0.00145201757 +0.00145761317 +0.00146322867 +0.00146886414 +0.00147451965 +0.00148019526 +0.00148589103 +0.00149160703 +0.00149734332 +0.00150309998 +0.00150887705 +0.00151467461 +0.00152049273 +0.00152633147 +0.00153219089 +0.00153807107 +0.00154397207 +0.00154989395 +0.00155583678 +0.00156180063 +0.00156778556 +0.00157379165 +0.00157981896 +0.00158586756 +0.00159193751 +0.00159802889 +0.00160414175 +0.00161027618 +0.00161643224 +0.00162260999 +0.00162880951 +0.00163503086 +0.00164127412 +0.00164753936 +0.00165382663 +0.00166013602 +0.0016664676 +0.00167282143 +0.00167919758 +0.00168559613 +0.00169201714 +0.00169846069 +0.00170492685 +0.00171141568 +0.00171792727 +0.00172446168 +0.00173101899 +0.00173759926 +0.00174420257 +0.001750829 +0.0017574786 +0.00176415147 +0.00177084767 +0.00177756727 +0.00178431035 +0.00179107698 +0.00179786723 +0.00180468119 +0.00181151891 +0.00181838049 +0.00182526599 +0.00183217549 +0.00183910906 +0.00184606678 +0.00185304873 +0.00186005497 +0.0018670856 +0.00187414067 +0.00188122027 +0.00188832448 +0.00189545337 +0.00190260702 +0.0019097855 +0.0019169889 +0.00192421729 +0.00193147075 +0.00193874936 +0.00194605319 +0.00195338233 +0.00196073684 +0.00196811682 +0.00197552234 +0.00198295349 +0.00199041033 +0.00199789294 +0.00200540142 +0.00201293584 +0.00202049628 +0.00202808281 +0.00203569553 +0.00204333451 +0.00205099983 +0.00205869158 +0.00206640983 +0.00207415468 +0.00208192619 +0.00208972445 +0.00209754955 +0.00210540157 +0.00211328059 +0.00212118669 +0.00212911996 +0.00213708048 +0.00214506833 +0.0021530836 +0.00216112638 +0.00216919674 +0.00217729478 +0.00218542057 +0.00219357421 +0.00220175577 +0.00220996535 +0.00221820302 +0.00222646888 +0.00223476301 +0.0022430855 +0.00225143643 +0.0022598159 +0.00226822398 +0.00227666077 +0.00228512636 +0.00229362082 +0.00230214426 +0.00231069675 +0.00231927839 +0.00232788927 +0.00233652947 +0.00234519908 +0.0023538982 +0.00236262691 +0.0023713853 +0.00238017347 +0.00238899149 +0.00239783948 +0.0024067175 +0.00241562567 +0.00242456406 +0.00243353277 +0.00244253189 +0.00245156151 +0.00246062173 +0.00246971263 +0.00247883431 +0.00248798687 +0.0024971704 +0.00250638498 +0.00251563072 +0.0025249077 +0.00253421603 +0.00254355579 +0.00255292709 +0.00256233001 +0.00257176465 +0.00258123111 +0.00259072947 +0.00260025985 +0.00260982233 +0.00261941701 +0.00262904399 +0.00263870336 +0.00264839522 +0.00265811967 +0.00266787681 +0.00267766673 +0.00268748953 +0.00269734531 +0.00270723417 +0.00271715621 +0.00272711153 +0.00273710022 +0.00274712238 +0.00275717812 +0.00276726754 +0.00277739073 +0.0027875478 +0.00279773885 +0.00280796397 +0.00281822327 +0.00282851686 +0.00283884483 +0.00284920728 +0.00285960432 +0.00287003605 +0.00288050258 +0.002891004 +0.00290154042 +0.00291211194 +0.00292271867 +0.00293336071 +0.00294403817 +0.00295475115 +0.00296549975 +0.00297628409 +0.00298710426 +0.00299796037 +0.00300885253 +0.00301978085 +0.00303074542 +0.00304174636 +0.00305278378 +0.00306385778 +0.00307496847 +0.00308611595 +0.00309730035 +0.00310852175 +0.00311978028 +0.00313107603 +0.00314240913 +0.00315377968 +0.00316518779 +0.00317663357 +0.00318811713 +0.00319963857 +0.00321119802 +0.00322279558 +0.00323443137 +0.00324610549 +0.00325781806 +0.00326956918 +0.00328135898 +0.00329318756 +0.00330505504 +0.00331696153 +0.00332890715 +0.003340892 +0.0033529162 +0.00336497987 +0.00337708312 +0.00338922607 +0.00340140883 +0.00341363151 +0.00342589424 +0.00343819712 +0.00345054028 +0.00346292383 +0.00347534789 +0.00348781258 +0.003500318 +0.00351286429 +0.00352545155 +0.00353807992 +0.00355074949 +0.0035634604 +0.00357621277 +0.0035890067 +0.00360184233 +0.00361471977 +0.00362763915 +0.00364060057 +0.00365360417 +0.00366665007 +0.00367973838 +0.00369286923 +0.00370604274 +0.00371925903 +0.00373251823 +0.00374582046 +0.00375916583 +0.00377255449 +0.00378598654 +0.00379946211 +0.00381298133 +0.00382654432 +0.0038401512 +0.00385380211 +0.00386749717 +0.0038812365 +0.00389502022 +0.00390884848 +0.00392272138 +0.00393663906 +0.00395060165 +0.00396460928 +0.00397866206 +0.00399276014 +0.00400690363 +0.00402109268 +0.00403532739 +0.00404960792 +0.00406393438 +0.0040783069 +0.00409272563 +0.00410719067 +0.00412170218 +0.00413626027 +0.00415086509 +0.00416551675 +0.00418021541 +0.00419496117 +0.00420975419 +0.00422459459 +0.0042394825 +0.00425441807 +0.00426940142 +0.00428443268 +0.004299512 +0.0043146395 +0.00432981533 +0.00434503962 +0.0043603125 +0.00437563411 +0.00439100459 +0.00440642406 +0.00442189269 +0.00443741058 +0.0044529779 +0.00446859476 +0.00448426132 +0.00449997771 +0.00451574407 +0.00453156054 +0.00454742726 +0.00456334437 +0.004579312 +0.0045953303 +0.00461139942 +0.00462751948 +0.00464369064 +0.00465991304 +0.00467618681 +0.0046925121 +0.00470888905 +0.00472531781 +0.00474179852 +0.00475833132 +0.00477491636 +0.00479155378 +0.00480824372 +0.00482498634 +0.00484178177 +0.00485863017 +0.00487553167 +0.00489248643 +0.00490949459 +0.0049265563 +0.00494367171 +0.00496084096 +0.0049780642 +0.00499534158 +0.00501267325 +0.00503005936 +0.00504750006 +0.00506499549 +0.00508254582 +0.00510015117 +0.00511781172 +0.00513552761 +0.00515329899 +0.005171126 +0.00518900882 +0.00520694758 +0.00522494244 +0.00524299355 +0.00526110107 +0.00527926515 +0.00529748594 +0.00531576361 +0.00533409829 +0.00535249015 +0.00537093935 +0.00538944603 +0.00540801036 +0.00542663249 +0.00544531259 +0.00546405079 +0.00548284727 +0.00550170218 +0.00552061568 +0.00553958793 +0.00555861908 +0.0055777093 +0.00559685875 +0.00561606758 +0.00563533596 +0.00565466404 +0.00567405199 +0.00569349997 +0.00571300813 +0.00573257665 +0.00575220569 +0.0057718954 +0.00579164595 +0.0058114575 +0.00583133022 +0.00585126428 +0.00587125982 +0.00589131703 +0.00591143607 +0.00593161709 +0.00595186027 +0.00597216578 +0.00599253377 +0.00601296442 +0.0060334579 +0.00605401436 +0.00607463399 +0.00609531694 +0.00611606339 +0.00613687351 +0.00615774746 +0.00617868542 +0.00619968755 +0.00622075402 +0.00624188501 +0.00626308069 +0.00628434123 +0.0063056668 +0.00632705758 +0.00634851373 +0.00637003542 +0.00639162284 +0.00641327616 +0.00643499555 +0.00645678118 +0.00647863323 +0.00650055188 +0.00652253729 +0.00654458966 +0.00656670914 +0.00658889593 +0.00661115019 +0.00663347211 +0.00665586185 +0.00667831961 +0.00670084556 +0.00672343987 +0.00674610273 +0.00676883431 +0.00679163481 +0.00681450439 +0.00683744323 +0.00686045153 +0.00688352945 +0.00690667719 +0.00692989492 +0.00695318282 +0.00697654109 +0.0069999699 +0.00702346944 +0.00704703989 +0.00707068143 +0.00709439425 +0.00711817854 +0.00714203449 +0.00716596226 +0.00718996207 +0.00721403408 +0.00723817849 +0.00726239549 +0.00728668525 +0.00731104799 +0.00733548387 +0.00735999309 +0.00738457583 +0.0074092323 +0.00743396268 +0.00745876715 +0.00748364592 +0.00750859916 +0.00753362709 +0.00755872987 +0.00758390772 +0.00760916081 +0.00763448935 +0.00765989353 +0.00768537354 +0.00771092957 +0.00773656183 +0.0077622705 +0.00778805579 +0.00781391788 +0.00783985698 +0.00786587328 +0.00789196697 +0.00791813827 +0.00794438736 +0.00797071444 +0.00799711971 +0.00802360337 +0.00805016562 +0.00807680666 +0.00810352669 +0.00813032592 +0.00815720453 +0.00818416274 +0.00821120074 +0.00823831874 +0.00826551694 +0.00829279554 +0.00832015475 +0.00834759477 +0.00837511581 +0.00840271807 +0.00843040175 +0.00845816706 +0.0084860142 +0.00851394339 +0.00854195483 +0.00857004872 +0.00859822528 +0.00862648471 +0.00865482722 +0.00868325301 +0.00871176231 +0.00874035531 +0.00876903222 +0.00879779327 +0.00882663865 +0.00885556858 +0.00888458327 +0.00891368293 +0.00894286778 +0.00897213803 +0.00900149388 +0.00903093556 +0.00906046328 +0.00909007725 +0.00911977768 +0.0091495648 +0.00917943882 +0.00920939995 +0.0092394484 +0.00926958441 +0.00929980818 +0.00933011993 +0.00936051988 +0.00939100825 +0.00942158525 +0.00945225111 +0.00948300605 +0.00951385028 +0.00954478403 +0.00957580752 +0.00960692096 +0.00963812459 +0.00966941861 +0.00970080326 +0.00973227876 +0.00976384533 +0.0097955032 +0.00982725258 +0.00985909371 +0.00989102681 +0.0099230521 +0.00995516981 +0.00998738017 +0.0100196834 +0.0100520797 +0.0100845694 +0.0101171526 +0.0101498296 +0.0101826006 +0.0102154659 +0.0102484256 +0.01028148 +0.0103146294 +0.0103478739 +0.0103812138 +0.0104146494 +0.0104481808 +0.0104818083 +0.0105155321 +0.0105493524 +0.0105832696 +0.0106172838 +0.0106513952 +0.0106856042 +0.0107199109 +0.0107543155 +0.0107888184 +0.0108234196 +0.0108581196 +0.0108929185 +0.0109278165 +0.0109628139 +0.010997911 +0.0110331079 +0.0110684049 +0.0111038023 +0.0111393003 +0.0111748991 +0.011210599 +0.0112464002 +0.0112823029 +0.0113183075 +0.011354414 +0.0113906229 +0.0114269343 +0.0114633485 +0.0114998657 +0.0115364862 +0.0115732102 +0.0116100379 +0.0116469697 +0.0116840056 +0.0117211461 +0.0117583914 +0.0117957416 +0.0118331971 +0.0118707581 +0.0119084248 +0.0119461975 +0.0119840764 +0.0120220619 +0.0120601541 +0.0120983533 +0.0121366597 +0.0121750736 +0.0122135953 +0.012252225 +0.012290963 +0.0123298095 +0.0123687648 +0.012407829 +0.0124470026 +0.0124862857 +0.0125256786 +0.0125651816 +0.0126047949 +0.0126445187 +0.0126843534 +0.0127242991 +0.0127643562 +0.0128045249 +0.0128448055 +0.0128851982 +0.0129257033 +0.012966321 +0.0130070516 +0.0130478954 +0.0130888527 +0.0131299236 +0.0131711085 +0.0132124077 +0.0132538213 +0.0132953497 +0.0133369931 +0.0133787518 +0.013420626 +0.013462616 +0.0135047222 +0.0135469447 +0.0135892838 +0.0136317398 +0.013674313 +0.0137170036 +0.0137598119 +0.0138027381 +0.0138457826 +0.0138889457 +0.0139322275 +0.0139756283 +0.0140191485 +0.0140627883 +0.0141065479 +0.0141504277 +0.0141944279 +0.0142385488 +0.0142827907 +0.0143271538 +0.0143716385 +0.0144162449 +0.0144609735 +0.0145058243 +0.0145507978 +0.0145958943 +0.0146411139 +0.0146864569 +0.0147319237 +0.0147775146 +0.0148232297 +0.0148690695 +0.0149150341 +0.0149611238 +0.015007339 +0.0150536799 +0.0151001468 +0.01514674 +0.0151934597 +0.0152403063 +0.01528728 +0.0153343812 +0.0153816101 +0.0154289669 +0.015476452 +0.0155240657 +0.0155718083 +0.01561968 +0.0156676811 +0.0157158119 +0.0157640728 +0.0158124639 +0.0158609856 +0.0159096382 +0.015958422 +0.0160073373 +0.0160563842 +0.0161055633 +0.0161548747 +0.0162043187 +0.0162538956 +0.0163036058 +0.0163534494 +0.0164034269 +0.0164535385 +0.0165037845 +0.0165541652 +0.0166046809 +0.0166553319 +0.0167061184 +0.0167570409 +0.0168080995 +0.0168592946 +0.0169106266 +0.0169620956 +0.0170137019 +0.017065446 +0.0171173281 +0.0171693484 +0.0172215074 +0.0172738052 +0.0173262423 +0.0173788188 +0.0174315352 +0.0174843916 +0.0175373885 +0.0175905261 +0.0176438048 +0.0176972247 +0.0177507863 +0.0178044899 +0.0178583357 +0.0179123241 +0.0179664553 +0.0180207297 +0.0180751476 +0.0181297094 +0.0181844152 +0.0182392654 +0.0182942604 +0.0183494004 +0.0184046858 +0.0184601169 +0.0185156939 +0.0185714172 +0.0186272872 +0.018683304 +0.0187394681 +0.0187957798 +0.0188522393 +0.018908847 +0.0189656032 +0.0190225083 +0.0190795625 +0.0191367661 +0.0191941195 +0.019251623 +0.0193092769 +0.0193670815 +0.0194250372 +0.0194831442 +0.019541403 +0.0195998137 +0.0196583768 +0.0197170926 +0.0197759613 +0.0198349834 +0.019894159 +0.0199534887 +0.0200129726 +0.0200726111 +0.0201324045 +0.0201923532 +0.0202524574 +0.0203127176 +0.020373134 +0.020433707 +0.0204944368 +0.0205553239 +0.0206163685 +0.020677571 +0.0207389317 +0.0208004509 +0.020862129 +0.0209239663 +0.0209859632 +0.0210481198 +0.0211104367 +0.0211729142 +0.0212355524 +0.0212983519 +0.0213613129 +0.0214244358 +0.0214877208 +0.0215511684 +0.0216147789 +0.0216785526 +0.0217424898 +0.0218065909 +0.0218708562 +0.0219352861 +0.0219998809 +0.0220646409 +0.0221295665 +0.0221946579 +0.0222599157 +0.0223253401 +0.0223909313 +0.0224566899 +0.0225226161 +0.0225887102 +0.0226549727 +0.0227214038 +0.0227880039 +0.0228547733 +0.0229217125 +0.0229888216 +0.0230561011 +0.0231235514 +0.0231911727 +0.0232589654 +0.0233269299 +0.0233950665 +0.0234633755 +0.0235318574 +0.0236005124 +0.0236693409 +0.0237383433 +0.0238075198 +0.023876871 +0.023946397 +0.0240160983 +0.0240859752 +0.024156028 +0.0242262572 +0.024296663 +0.0243672459 +0.0244380061 +0.0245089441 +0.0245800602 +0.0246513547 +0.024722828 +0.0247944804 +0.0248663124 +0.0249383242 +0.0250105163 +0.0250828889 +0.0251554425 +0.0252281773 +0.0253010939 +0.0253741924 +0.0254474734 +0.025520937 +0.0255945838 +0.0256684141 +0.0257424281 +0.0258166264 +0.0258910092 +0.0259655769 +0.0260403299 +0.0261152685 +0.0261903931 +0.0262657041 +0.0263412018 +0.0264168867 +0.026492759 +0.0265688191 +0.0266450674 +0.0267215043 +0.0267981301 +0.0268749452 +0.02695195 +0.0270291449 +0.0271065301 +0.0271841061 +0.0272618733 +0.0273398319 +0.0274179825 +0.0274963253 +0.0275748608 +0.0276535892 +0.0277325111 +0.0278116267 +0.0278909364 +0.0279704406 +0.0280501396 +0.0281300339 +0.0282101239 +0.0282904098 +0.0283708921 +0.0284515712 +0.0285324473 +0.028613521 +0.0286947925 +0.0287762624 +0.0288579308 +0.0289397982 +0.0290218651 +0.0291041317 +0.0291865984 +0.0292692657 +0.0293521339 +0.0294352034 +0.0295184746 +0.0296019478 +0.0296856235 +0.0297695019 +0.0298535836 +0.0299378689 +0.0300223581 +0.0301070517 +0.03019195 +0.0302770534 +0.0303623624 +0.0304478772 +0.0305335983 +0.0306195261 +0.0307056609 +0.0307920032 +0.0308785533 +0.0309653116 +0.0310522785 +0.0311394545 +0.0312268397 +0.0313144348 +0.03140224 +0.0314902558 +0.0315784825 +0.0316669205 +0.0317555703 +0.0318444322 +0.0319335065 +0.0320227938 +0.0321122944 +0.0322020086 +0.032291937 +0.0323820798 +0.0324724374 +0.0325630104 +0.032653799 +0.0327448036 +0.0328360247 +0.0329274626 +0.0330191178 +0.0331109906 +0.0332030814 +0.0332953907 +0.0333879188 +0.0334806661 +0.0335736331 +0.0336668201 +0.0337602275 +0.0338538557 +0.0339477051 +0.0340417762 +0.0341360693 +0.0342305849 +0.0343253232 +0.0344202848 +0.03451547 +0.0346108793 +0.034706513 +0.0348023715 +0.0348984553 +0.0349947647 +0.0350913002 +0.0351880621 +0.0352850509 +0.035382267 +0.0354797108 +0.0355773826 +0.0356752829 +0.0357734121 +0.0358717706 +0.0359703588 +0.0360691772 +0.036168226 +0.0362675058 +0.0363670169 +0.0364667598 +0.0365667348 +0.0366669424 +0.036767383 +0.036868057 +0.0369689648 +0.0370701068 +0.0371714834 +0.037273095 +0.0373749421 +0.0374770251 +0.0375793443 +0.0376819002 +0.0377846932 +0.0378877237 +0.0379909922 +0.0380944989 +0.0381982445 +0.0383022292 +0.0384064535 +0.0385109178 +0.0386156225 +0.038720568 +0.0388257548 +0.0389311833 +0.0390368538 +0.0391427669 +0.0392489228 +0.0393553221 +0.0394619652 +0.0395688524 +0.0396759843 +0.0397833611 +0.0398909834 +0.0399988515 +0.0401069659 +0.0402153269 +0.0403239351 +0.0404327909 +0.0405418946 +0.0406512466 +0.0407608475 +0.0408706976 +0.0409807973 +0.0410911471 +0.0412017474 +0.0413125986 +0.0414237011 +0.0415350554 +0.0416466619 +0.041758521 +0.0418706331 +0.0419829987 +0.0420956182 +0.042208492 +0.0423216205 +0.0424350042 +0.0425486435 +0.0426625388 +0.0427766905 +0.0428910991 +0.043005765 +0.0431206887 +0.0432358705 +0.0433513108 +0.0434670102 +0.043582969 +0.0436991877 +0.0438156667 +0.0439324064 +0.0440494073 +0.0441666698 +0.0442841943 +0.0444019812 +0.0445200311 +0.0446383442 +0.0447569211 +0.0448757621 +0.0449948678 +0.0451142385 +0.0452338747 +0.0453537767 +0.0454739452 +0.0455943803 +0.0457150827 +0.0458360528 +0.0459572909 +0.0460787975 +0.046200573 +0.046322618 +0.0464449327 +0.0465675177 +0.0466903734 +0.0468135001 +0.0469368985 +0.0470605688 +0.0471845115 +0.0473087271 +0.047433216 +0.0475579787 +0.0476830155 +0.0478083269 +0.0479339134 +0.0480597753 +0.0481859132 +0.0483123274 +0.0484390184 +0.0485659867 +0.0486932327 +0.0488207567 +0.0489485593 +0.0490766409 +0.049205002 +0.0493336429 +0.0494625641 +0.0495917661 +0.0497212492 +0.049851014 +0.0499810609 +0.0501113903 +0.0502420027 +0.0503728984 +0.050504078 +0.0506355419 +0.0507672905 +0.0508993242 +0.0510316436 +0.051164249 +0.0512971409 +0.0514303198 +0.051563786 +0.0516975401 +0.0518315824 +0.0519659134 +0.0521005336 +0.0522354434 +0.0523706432 +0.0525061335 +0.0526419147 +0.0527779873 +0.0529143517 +0.0530510084 +0.0531879578 +0.0533252003 +0.0534627364 +0.0536005666 +0.0537386913 +0.0538771109 +0.0540158259 +0.0541548367 +0.0542941438 +0.0544337476 +0.0545736485 +0.0547138471 +0.0548543437 +0.0549951389 +0.055136233 +0.0552776265 +0.0554193198 +0.0555613134 +0.0557036078 +0.0558462034 +0.0559891006 +0.0561322998 +0.0562758016 +0.0564196064 +0.0565637147 +0.0567081268 +0.0568528432 +0.0569978644 +0.0571431908 +0.0572888229 +0.0574347611 +0.0575810059 +0.0577275577 +0.0578744169 +0.0580215841 +0.0581690596 +0.058316844 +0.0584649376 +0.0586133409 +0.0587620544 +0.0589110785 +0.0590604137 +0.0592100604 +0.059360019 +0.0595102901 +0.059660874 +0.0598117713 +0.0599629823 +0.0601145075 +0.0602663473 +0.0604185023 +0.0605709729 +0.0607237595 +0.0608768625 +0.0610302825 +0.0611840198 +0.0613380749 +0.0614924483 +0.0616471405 +0.0618021518 +0.0619574827 +0.0621131337 +0.0622691053 +0.0624253978 +0.0625820117 +0.0627389475 +0.0628962057 +0.0630537866 +0.0632116907 +0.0633699186 +0.0635284706 +0.0636873472 +0.0638465488 +0.0640060759 +0.0641659289 +0.0643261083 +0.0644866146 +0.0646474482 +0.0648086095 +0.0649700991 +0.0651319173 +0.0652940645 +0.0654565414 +0.0656193482 +0.0657824856 +0.0659459538 +0.0661097534 +0.0662738848 +0.0664383484 +0.0666031448 +0.0667682743 +0.0669337375 +0.0670995348 +0.0672656665 +0.0674321333 +0.0675989354 +0.0677660735 +0.0679335479 +0.068101359 +0.0682695074 +0.0684379935 +0.0686068177 +0.0687759805 +0.0689454823 +0.0691153237 +0.0692855049 +0.0694560266 +0.0696268891 +0.0697980929 +0.0699696384 +0.0701415262 +0.0703137566 +0.07048633 +0.0706592471 +0.0708325081 +0.0710061136 +0.071180064 +0.0713543597 +0.0715290013 +0.071703989 +0.0718793235 +0.0720550052 +0.0722310344 +0.0724074117 +0.0725841375 +0.0727612123 +0.0729386365 +0.0731164105 +0.0732945348 +0.0734730098 +0.0736518361 +0.073831014 +0.0740105441 +0.0741904266 +0.0743706622 +0.0745512512 +0.0747321941 +0.0749134914 +0.0750951434 +0.0752771507 +0.0754595137 +0.0756422328 +0.0758253085 +0.0760087412 +0.0761925314 +0.0763766796 +0.0765611861 +0.0767460515 +0.0769312761 +0.0771168604 +0.0773028049 +0.07748911 +0.0776757762 +0.0778628039 +0.0780501935 +0.0782379456 +0.0784260605 +0.0786145386 +0.0788033805 +0.0789925866 +0.0791821573 +0.0793720931 +0.0795623944 +0.0797530617 +0.0799440954 +0.0801354959 +0.0803272637 +0.0805193993 +0.0807119031 +0.0809047754 +0.0810980169 +0.0812916279 +0.0814856088 +0.0816799601 +0.0818746823 +0.0820697758 +0.0822652409 +0.0824610783 +0.0826572883 +0.0828538713 +0.0830508278 +0.0832481583 +0.0834458631 +0.0836439428 +0.0838423977 +0.0840412284 +0.0842404351 +0.0844400185 +0.0846399788 +0.0848403167 +0.0850410324 +0.0852421265 +0.0854435993 +0.0856454514 +0.0858476831 +0.0860502949 +0.0862532873 +0.0864566606 +0.0866604153 +0.0868645518 +0.0870690707 +0.0872739722 +0.0874792569 +0.0876849252 +0.0878909775 +0.0880974142 +0.0883042359 +0.0885114429 +0.0887190356 +0.0889270146 +0.0891353801 +0.0893441328 +0.0895532729 +0.0897628009 +0.0899727173 +0.0901830226 +0.090393717 +0.0906048011 +0.0908162753 +0.09102814 +0.0912403956 +0.0914530426 +0.0916660815 +0.0918795126 +0.0920933363 +0.0923075532 +0.0925221636 +0.0927371679 +0.0929525666 +0.0931683602 +0.0933845489 +0.0936011334 +0.0938181139 +0.094035491 +0.094253265 +0.0944714363 +0.0946900055 +0.0949089729 +0.0951283389 +0.095348104 +0.0955682686 +0.0957888331 +0.0960097979 +0.0962311635 +0.0964529303 +0.0966750987 +0.0968976692 +0.097120642 +0.0973440178 +0.0975677968 +0.0977919795 +0.0980165664 +0.0982415578 +0.0984669542 +0.098692756 +0.0989189635 +0.0991455773 +0.0993725977 +0.0996000252 +0.0998278601 +0.100056103 +0.100284754 +0.100513814 +0.100743283 +0.100973161 +0.10120345 +0.101434149 +0.101665258 +0.101896779 +0.102128711 +0.102361056 +0.102593813 +0.102826982 +0.103060565 +0.103294562 +0.103528972 +0.103763798 +0.103999038 +0.104234693 +0.104470764 +0.104707251 +0.104944154 +0.105181475 +0.105419213 +0.105657368 +0.105895942 +0.106134934 +0.106374345 +0.106614175 +0.106854426 +0.107095096 +0.107336187 +0.107577698 +0.107819632 +0.108061986 +0.108304763 +0.108547963 +0.108791585 +0.109035631 +0.1092801 +0.109524994 +0.109770312 +0.110016055 +0.110262223 +0.110508817 +0.110755837 +0.111003284 +0.111251157 +0.111499458 +0.111748186 +0.111997343 +0.112246928 +0.112496941 +0.112747384 +0.112998256 +0.113249559 +0.113501292 +0.113753455 +0.11400605 +0.114259076 +0.114512534 +0.114766425 +0.115020748 +0.115275504 +0.115530694 +0.115786317 +0.116042375 +0.116298867 +0.116555794 +0.116813157 +0.117070955 +0.117329189 +0.11758786 +0.117846968 +0.118106513 +0.118366495 +0.118626915 +0.118887774 +0.119149072 +0.119410808 +0.119672984 +0.1199356 +0.120198656 +0.120462153 +0.120726091 +0.12099047 +0.12125529 +0.121520553 +0.121786258 +0.122052406 +0.122318997 +0.122586031 +0.122853509 +0.123121432 +0.123389799 +0.123658611 +0.123927868 +0.124197571 +0.124467721 +0.124738316 +0.125009358 +0.125280847 +0.125552784 +0.125825169 +0.126098001 +0.126371282 +0.126645013 +0.126919192 +0.127193821 +0.127468899 +0.127744428 +0.128020408 +0.128296839 +0.12857372 +0.128851054 +0.12912884 +0.129407078 +0.129685768 +0.129964912 +0.130244509 +0.130524559 +0.130805064 +0.131086023 +0.131367437 +0.131649306 +0.131931631 +0.132214411 +0.132497647 +0.13278134 +0.133065489 +0.133350096 +0.13363516 +0.133920681 +0.134206661 +0.134493099 +0.134779996 +0.135067352 +0.135355168 +0.135643443 +0.135932178 +0.136221373 +0.13651103 +0.136801147 +0.137091725 +0.137382766 +0.137674268 +0.137966233 +0.13825866 +0.13855155 +0.138844903 +0.13913872 +0.139433001 +0.139727746 +0.140022955 +0.14031863 +0.140614769 +0.140911374 +0.141208445 +0.141505982 +0.141803985 +0.142102455 +0.142401392 +0.142700796 +0.143000667 +0.143301007 +0.143601815 +0.143903091 +0.144204836 +0.144507051 +0.144809734 +0.145112887 +0.145416511 +0.145720604 +0.146025168 +0.146330203 +0.14663571 +0.146941687 +0.147248137 +0.147555058 +0.147862452 +0.148170318 +0.148478658 +0.14878747 +0.149096756 +0.149406516 +0.149716749 +0.150027457 +0.15033864 +0.150650297 +0.15096243 +0.151275038 +0.151588122 +0.151901682 +0.152215718 +0.15253023 +0.152845219 +0.153160686 +0.153476629 +0.153793051 +0.15410995 +0.154427327 +0.154745183 +0.155063517 +0.155382331 +0.155701623 +0.156021395 +0.156341647 +0.156662378 +0.15698359 +0.157305283 +0.157627456 +0.15795011 +0.158273245 +0.158596862 +0.158920961 +0.159245541 +0.159570604 +0.159896149 +0.160222177 +0.160548689 +0.160875683 +0.161203161 +0.161531122 +0.161859568 +0.162188497 +0.162517911 +0.16284781 +0.163178194 +0.163509063 +0.163840417 +0.164172257 +0.164504582 +0.164837394 +0.165170692 +0.165504477 +0.165838748 +0.166173506 +0.166508752 +0.166844485 +0.167180705 +0.167517414 +0.16785461 +0.168192295 +0.168530468 +0.168869131 +0.169208282 +0.169547922 +0.169888051 +0.170228671 +0.17056978 +0.170911379 +0.171253468 +0.171596048 +0.171939118 +0.172282679 +0.172626731 +0.172971274 +0.173316309 +0.173661836 +0.174007854 +0.174354364 +0.174701367 +0.175048862 +0.175396849 +0.17574533 +0.176094303 +0.176443769 +0.176793729 +0.177144182 +0.177495129 +0.17784657 +0.178198506 +0.178550935 +0.178903859 +0.179257277 +0.17961119 +0.179965598 +0.180320502 +0.1806759 +0.181031795 +0.181388184 +0.18174507 +0.182102452 +0.182460329 +0.182818704 +0.183177574 +0.183536941 +0.183896805 +0.184257166 +0.184618025 +0.18497938 +0.185341233 +0.185703583 +0.186066431 +0.186429778 +0.186793622 +0.187157964 +0.187522805 +0.187888144 +0.188253981 +0.188620318 +0.188987153 +0.189354488 +0.189722321 +0.190090654 +0.190459486 +0.190828818 +0.19119865 +0.191568981 +0.191939813 +0.192311144 +0.192682976 +0.193055308 +0.193428141 +0.193801474 +0.194175308 +0.194549642 +0.194924478 +0.195299815 +0.195675652 +0.196051992 +0.196428832 +0.196806174 +0.197184018 +0.197562363 +0.19794121 +0.19832056 +0.198700411 +0.199080764 +0.19946162 +0.199842977 +0.200224838 +0.200607201 +0.200990066 +0.201373434 +0.201757305 +0.202141679 +0.202526556 +0.202911936 +0.203297819 +0.203684205 +0.204071094 +0.204458487 +0.204846384 +0.205234783 +0.205623687 +0.206013094 +0.206403005 +0.20679342 +0.207184338 +0.207575761 +0.207967688 +0.208360118 +0.208753053 +0.209146492 +0.209540436 +0.209934883 +0.210329835 +0.210725292 +0.211121253 +0.211517718 +0.211914688 +0.212312163 +0.212710142 +0.213108627 +0.213507615 +0.213907109 +0.214307108 +0.214707611 +0.215108619 +0.215510132 +0.215912151 +0.216314674 +0.216717702 +0.217121236 +0.217525274 +0.217929818 +0.218334866 +0.21874042 +0.219146479 +0.219553043 +0.219960113 +0.220367688 +0.220775767 +0.221184353 +0.221593443 +0.222003039 +0.22241314 +0.222823746 +0.223234858 +0.223646474 +0.224058596 +0.224471224 +0.224884356 +0.225297994 +0.225712137 +0.226126786 +0.22654194 +0.226957598 +0.227373762 +0.227790432 +0.228207606 +0.228625286 +0.22904347 +0.22946216 +0.229881355 +0.230301055 +0.23072126 +0.23114197 +0.231563185 +0.231984905 +0.232407129 +0.232829859 +0.233253093 +0.233676832 +0.234101076 +0.234525825 +0.234951078 +0.235376836 +0.235803098 +0.236229865 +0.236657136 +0.237084911 +0.237513191 +0.237941975 +0.238371264 +0.238801056 +0.239231353 +0.239662153 +0.240093458 +0.240525266 +0.240957578 +0.241390394 +0.241823713 +0.242257536 +0.242691862 +0.243126692 +0.243562025 +0.243997862 +0.244434201 +0.244871044 +0.245308389 +0.245746238 +0.246184589 +0.246623442 +0.247062799 +0.247502658 +0.247943019 +0.248383882 +0.248825248 +0.249267116 +0.249709485 +0.250152357 +0.25059573 +0.251039605 +0.251483981 +0.251928858 +0.252374237 +0.252820117 +0.253266498 +0.25371338 +0.254160763 +0.254608646 +0.255057029 +0.255505913 +0.255955298 +0.256405182 +0.256855566 +0.25730645 +0.257757833 +0.258209716 +0.258662099 +0.25911498 +0.259568361 +0.260022241 +0.260476619 +0.260931496 +0.261386871 +0.261842744 +0.262299116 +0.262755985 +0.263213352 +0.263671217 +0.264129579 +0.264588439 +0.265047795 +0.265507648 +0.265967998 +0.266428845 +0.266890188 +0.267352027 +0.267814362 +0.268277192 +0.268740519 +0.26920434 +0.269668657 +0.270133469 +0.270598776 +0.271064577 +0.271530872 +0.271997662 +0.272464946 +0.272932723 +0.273400994 +0.273869758 +0.274339016 +0.274808766 +0.275279009 +0.275749744 +0.276220972 +0.276692692 +0.277164903 +0.277637606 +0.2781108 +0.278584485 +0.279058662 +0.279533328 +0.280008485 +0.280484132 +0.280960269 +0.281436896 +0.281914012 +0.282391617 +0.282869711 +0.283348293 +0.283827364 +0.284306923 +0.28478697 +0.285267504 +0.285748526 +0.286230035 +0.28671203 +0.287194512 +0.28767748 +0.288160934 +0.288644874 +0.289129299 +0.289614209 +0.290099604 +0.290585483 +0.291071846 +0.291558694 +0.292046025 +0.29253384 +0.293022137 +0.293510917 +0.29400018 +0.294489925 +0.294980152 +0.29547086 +0.295962049 +0.296453719 +0.29694587 +0.297438501 +0.297931612 +0.298425203 +0.298919273 +0.299413822 +0.299908849 +0.300404355 +0.300900339 +0.301396801 +0.301893739 +0.302391155 +0.302889047 +0.303387416 +0.303886261 +0.304385581 +0.304885376 +0.305385646 +0.305886391 +0.30638761 +0.306889303 +0.307391469 +0.307894108 +0.30839722 +0.308900805 +0.309404861 +0.309909389 +0.310414388 +0.310919858 +0.311425799 +0.311932209 +0.31243909 +0.312946439 +0.313454258 +0.313962545 +0.314471301 +0.314980524 +0.315490214 +0.316000372 +0.316510996 +0.317022086 +0.317533642 +0.318045663 +0.318558149 +0.3190711 +0.319584515 +0.320098393 +0.320612735 +0.32112754 +0.321642807 +0.322158536 +0.322674727 +0.323191379 +0.323708491 +0.324226064 +0.324744097 +0.325262589 +0.32578154 +0.32630095 +0.326820818 +0.327341143 +0.327861926 +0.328383165 +0.32890486 +0.329427012 +0.329949618 +0.33047268 +0.330996196 +0.331520166 +0.332044589 +0.332569466 +0.333094795 +0.333620576 +0.334146809 +0.334673492 +0.335200627 +0.335728211 +0.336256246 +0.336784729 +0.337313661 +0.337843041 +0.338372869 +0.338903144 +0.339433866 +0.339965034 +0.340496648 +0.341028707 +0.34156121 +0.342094158 +0.342627549 +0.343161383 +0.34369566 +0.344230379 +0.34476554 +0.345301142 +0.345837184 +0.346373666 +0.346910587 +0.347447948 +0.347985747 +0.348523983 +0.349062657 +0.349601768 +0.350141314 +0.350681297 +0.351221714 +0.351762566 +0.352303852 +0.352845572 +0.353387724 +0.353930308 +0.354473325 +0.355016772 +0.35556065 +0.356104958 +0.356649695 +0.357194862 +0.357740456 +0.358286479 +0.358832928 +0.359379804 +0.359927106 +0.360474833 +0.361022985 +0.361571561 +0.36212056 +0.362669983 +0.363219828 +0.363770094 +0.364320782 +0.36487189 +0.365423419 +0.365975366 +0.366527732 +0.367080516 +0.367633718 +0.368187337 +0.368741371 +0.369295821 +0.369850687 +0.370405966 +0.370961659 +0.371517765 +0.372074284 +0.372631214 +0.373188555 +0.373746307 +0.374304468 +0.374863039 +0.375422018 +0.375981405 +0.376541199 +0.3771014 +0.377662006 +0.378223017 +0.378784434 +0.379346253 +0.379908476 +0.380471102 +0.381034129 +0.381597558 +0.382161387 +0.382725615 +0.383290243 +0.383855269 +0.384420692 +0.384986513 +0.38555273 +0.386119342 +0.38668635 +0.387253751 +0.387821546 +0.388389734 +0.388958314 +0.389527285 +0.390096647 +0.390666398 +0.391236539 +0.391807068 +0.392377985 +0.392949289 +0.393520979 +0.394093055 +0.394665515 +0.39523836 +0.395811588 +0.396385198 +0.39695919 +0.397533564 +0.398108317 +0.39868345 +0.399258962 +0.399834852 +0.40041112 +0.400987764 +0.401564783 +0.402142178 +0.402719947 +0.403298089 +0.403876604 +0.404455491 +0.405034749 +0.405614377 +0.406194375 +0.406774742 +0.407355477 +0.407936579 +0.408518047 +0.409099881 +0.40968208 +0.410264643 +0.410847569 +0.411430857 +0.412014507 +0.412598518 +0.413182889 +0.413767619 +0.414352707 +0.414938153 +0.415523955 +0.416110114 +0.416696627 +0.417283495 +0.417870716 +0.41845829 +0.419046215 +0.419634492 +0.420223118 +0.420812093 +0.421401417 +0.421991089 +0.422581107 +0.423171471 +0.42376218 +0.424353233 +0.424944629 +0.425536367 +0.426128448 +0.426720868 +0.427313629 +0.427906728 +0.428500166 +0.42909394 +0.429688051 +0.430282498 +0.430877278 +0.431472393 +0.43206784 +0.432663619 +0.433259729 +0.433856169 +0.434452938 +0.435050036 +0.435647461 +0.436245212 +0.436843289 +0.437441691 +0.438040416 +0.438639464 +0.439238834 +0.439838525 +0.440438536 +0.441038866 +0.441639515 +0.442240481 +0.442841763 +0.44344336 +0.444045272 +0.444647498 +0.445250036 +0.445852886 +0.446456046 +0.447059517 +0.447663296 +0.448267383 +0.448871777 +0.449476477 +0.450081482 +0.450686791 +0.451292404 +0.451898318 +0.452504533 +0.453111049 +0.453717864 +0.454324977 +0.454932387 +0.455540094 +0.456148096 +0.456756392 +0.457364982 +0.457973864 +0.458583038 +0.459192501 +0.459802255 +0.460412296 +0.461022625 +0.46163324 +0.462244141 +0.462855326 +0.463466794 +0.464078545 +0.464690577 +0.465302889 +0.465915481 +0.466528351 +0.467141498 +0.467754921 +0.46836862 +0.468982593 +0.469596839 +0.470211357 +0.470826146 +0.471441205 +0.472056533 +0.472672129 +0.473287992 +0.473904121 +0.474520514 +0.475137172 +0.475754092 +0.476371273 +0.476988716 +0.477606417 +0.478224378 +0.478842595 +0.479461069 +0.480079798 +0.480698782 +0.481318018 +0.481937507 +0.482557246 +0.483177235 +0.483797473 +0.484417959 +0.485038692 +0.485659669 +0.486280892 +0.486902357 +0.487524065 +0.488146014 +0.488768203 +0.489390631 +0.490013297 +0.4906362 +0.491259338 +0.49188271 +0.492506316 +0.493130154 +0.493754224 +0.494378523 +0.495003051 +0.495627807 +0.49625279 +0.496877998 +0.497503431 +0.498129087 +0.498754964 +0.499381063 +0.500007382 +0.500633919 +0.501260674 +0.501887645 +0.502514832 +0.503142232 +0.503769846 +0.504397671 +0.505025707 +0.505653952 +0.506282406 +0.506911067 +0.507539934 +0.508169005 +0.50879828 +0.509427758 +0.510057437 +0.510687315 +0.511317393 +0.511947669 +0.512578141 +0.513208808 +0.51383967 +0.514470724 +0.515101971 +0.515733408 +0.516365034 +0.516996849 +0.51762885 +0.518261037 +0.518893409 +0.519525964 +0.520158702 +0.52079162 +0.521424718 +0.522057995 +0.522691449 +0.523325079 +0.523958884 +0.524592862 +0.525227013 +0.525861335 +0.526495827 +0.527130488 +0.527765316 +0.528400311 +0.52903547 +0.529670794 +0.530306279 +0.530941926 +0.531577734 +0.532213699 +0.532849823 +0.533486102 +0.534122537 +0.534759126 +0.535395867 +0.536032759 +0.536669801 +0.537306992 +0.53794433 +0.538581815 +0.539219445 +0.539857218 +0.540495133 +0.54113319 +0.541771386 +0.542409721 +0.543048193 +0.543686801 +0.544325544 +0.54496442 +0.545603428 +0.546242567 +0.546881836 +0.547521233 +0.548160756 +0.548800406 +0.549440179 +0.550080076 +0.550720094 +0.551360232 +0.55200049 +0.552640866 +0.553281357 +0.553921964 +0.554562685 +0.555203519 +0.555844463 +0.556485517 +0.55712668 +0.55776795 +0.558409326 +0.559050807 +0.55969239 +0.560334076 +0.560975862 +0.561617747 +0.56225973 +0.562901809 +0.563543984 +0.564186253 +0.564828614 +0.565471066 +0.566113608 +0.566756238 +0.567398955 +0.568041758 +0.568684645 +0.569327616 +0.569970667 +0.5706138 +0.571257011 +0.571900299 +0.572543664 +0.573187103 +0.573830616 +0.574474201 +0.575117856 +0.575761581 +0.576405374 +0.577049233 +0.577693157 +0.578337145 +0.578981195 +0.579625306 +0.580269477 +0.580913706 +0.581557992 +0.582202333 +0.582846728 +0.583491176 +0.584135674 +0.584780223 +0.58542482 +0.586069464 +0.586714153 +0.587358887 +0.588003663 +0.588648481 +0.589293338 +0.589938234 +0.590583167 +0.591228136 +0.591873138 +0.592518174 +0.593163241 +0.593808338 +0.594453463 +0.595098616 +0.595743794 +0.596388996 +0.597034222 +0.597679468 +0.598324734 +0.598970019 +0.599615321 +0.600260638 +0.60090597 +0.601551314 +0.60219667 +0.602842035 +0.603487408 +0.604132789 +0.604778175 +0.605423564 +0.606068957 +0.60671435 +0.607359743 +0.608005134 +0.608650522 +0.609295905 +0.609941281 +0.61058665 +0.61123201 +0.611877359 +0.612522696 +0.613168019 +0.613813327 +0.614458618 +0.615103892 +0.615749146 +0.616394379 +0.617039589 +0.617684775 +0.618329936 +0.61897507 +0.619620175 +0.620265251 +0.620910295 +0.621555306 +0.622200282 +0.622845223 +0.623490126 +0.62413499 +0.624779814 +0.625424596 +0.626069334 +0.626714028 +0.627358675 +0.628003274 +0.628647824 +0.629292322 +0.629936768 +0.63058116 +0.631225497 +0.631869776 +0.632513997 +0.633158158 +0.633802258 +0.634446294 +0.635090265 +0.635734171 +0.636378008 +0.637021777 +0.637665474 +0.6383091 +0.638952651 +0.639596127 +0.640239527 +0.640882848 +0.641526088 +0.642169248 +0.642812324 +0.643455316 +0.644098222 +0.64474104 +0.645383769 +0.646026407 +0.646668953 +0.647311405 +0.647953762 +0.648596021 +0.649238183 +0.649880244 +0.650522203 +0.65116406 +0.651805812 +0.652447457 +0.653088995 +0.653730423 +0.65437174 +0.655012945 +0.655654036 +0.656295011 +0.656935869 +0.657576608 +0.658217227 +0.658857724 +0.659498098 +0.660138346 +0.660778468 +0.661418462 +0.662058326 +0.662698058 +0.663337658 +0.663977123 +0.664616452 +0.665255644 +0.665894696 +0.666533607 +0.667172377 +0.667811002 +0.668449481 +0.669087814 +0.669725997 +0.670364031 +0.671001912 +0.67163964 +0.672277213 +0.672914629 +0.673551887 +0.674188985 +0.674825922 +0.675462696 +0.676099304 +0.676735747 +0.677372022 +0.678008127 +0.678644062 +0.679279823 +0.679915411 +0.680550823 +0.681186057 +0.681821112 +0.682455986 +0.683090678 +0.683725187 +0.684359509 +0.684993645 +0.685627592 +0.686261349 +0.686894914 +0.687528285 +0.688161461 +0.68879444 +0.689427221 +0.690059802 +0.690692181 +0.691324357 +0.691956328 +0.692588093 +0.69321965 +0.693850997 +0.694482132 +0.695113055 +0.695743763 +0.696374255 +0.697004529 +0.697634583 +0.698264417 +0.698894028 +0.699523414 +0.700152575 +0.700781508 +0.701410211 +0.702038684 +0.702666924 +0.703294931 +0.703922701 +0.704550234 +0.705177529 +0.705804582 +0.706431393 +0.707057961 +0.707684282 +0.708310357 +0.708936183 +0.709561758 +0.710187081 +0.710812151 +0.711436965 +0.712061522 +0.71268582 +0.713309859 +0.713933635 +0.714557147 +0.715180395 +0.715803375 +0.716426087 +0.717048529 +0.717670699 +0.718292596 +0.718914217 +0.719535562 +0.720156629 +0.720777415 +0.72139792 +0.722018141 +0.722638078 +0.723257727 +0.723877089 +0.724496161 +0.725114941 +0.725733427 +0.726351619 +0.726969515 +0.727587112 +0.728204409 +0.728821405 +0.729438098 +0.730054486 +0.730670568 +0.731286341 +0.731901805 +0.732516957 +0.733131796 +0.733746321 +0.734360529 +0.734974419 +0.735587989 +0.736201238 +0.736814164 +0.737426766 +0.738039041 +0.738650988 +0.739262605 +0.739873891 +0.740484844 +0.741095463 +0.741705745 +0.74231569 +0.742925295 +0.743534558 +0.744143479 +0.744752055 +0.745360285 +0.745968167 +0.746575699 +0.74718288 +0.747789708 +0.748396182 +0.7490023 +0.749608059 +0.75021346 +0.750818499 +0.751423175 +0.752027486 +0.752631432 +0.75323501 +0.753838218 +0.754441055 +0.755043519 +0.755645609 +0.756247322 +0.756848658 +0.757449614 +0.758050189 +0.758650382 +0.75925019 +0.759849611 +0.760448645 +0.76104729 +0.761645543 +0.762243404 +0.76284087 +0.763437941 +0.764034613 +0.764630886 +0.765226758 +0.765822227 +0.766417292 +0.76701195 +0.767606201 +0.768200043 +0.768793473 +0.769386491 +0.769979094 +0.770571282 +0.771163051 +0.771754402 +0.772345331 +0.772935838 +0.77352592 +0.774115576 +0.774704804 +0.775293604 +0.775881972 +0.776469907 +0.777057409 +0.777644474 +0.778231102 +0.77881729 +0.779403037 +0.779988342 +0.780573203 +0.781157617 +0.781741585 +0.782325102 +0.782908169 +0.783490784 +0.784072944 +0.784654648 +0.785235895 +0.785816682 +0.786397009 +0.786976874 +0.787556274 +0.788135208 +0.788713675 +0.789291673 +0.7898692 +0.790446255 +0.791022835 +0.79159894 +0.792174568 +0.792749716 +0.793324384 +0.793898569 +0.794472271 +0.795045487 +0.795618216 +0.796190455 +0.796762205 +0.797333462 +0.797904225 +0.798474492 +0.799044263 +0.799613535 +0.800182306 +0.800750575 +0.80131834 +0.801885601 +0.802452354 +0.803018598 +0.803584332 +0.804149554 +0.804714263 +0.805278456 +0.805842133 +0.806405291 +0.806967929 +0.807530045 +0.808091638 +0.808652706 +0.809213247 +0.809773259 +0.810332742 +0.810891693 +0.811450111 +0.812007994 +0.812565341 +0.81312215 +0.813678418 +0.814234146 +0.81478933 +0.81534397 +0.815898064 +0.816451609 +0.817004605 +0.81755705 +0.818108943 +0.818660281 +0.819211063 +0.819761287 +0.820310952 +0.820860056 +0.821408598 +0.821956575 +0.822503987 +0.823050832 +0.823597108 +0.824142813 +0.824687945 +0.825232505 +0.825776488 +0.826319895 +0.826862723 +0.827404971 +0.827946637 +0.828487719 +0.829028217 +0.829568127 +0.83010745 +0.830646183 +0.831184324 +0.831721872 +0.832258825 +0.832795182 +0.833330941 +0.833866101 +0.83440066 +0.834934616 +0.835467968 +0.836000713 +0.836532852 +0.837064381 +0.8375953 +0.838125606 +0.838655299 +0.839184376 +0.839712837 +0.840240678 +0.8407679 +0.8412945 +0.841820476 +0.842345828 +0.842870553 +0.84339465 +0.843918117 +0.844440953 +0.844963157 +0.845484726 +0.846005659 +0.846525954 +0.84704561 +0.847564626 +0.848083 +0.84860073 +0.849117814 +0.849634251 +0.85015004 +0.850665179 +0.851179667 +0.851693501 +0.85220668 +0.852719203 +0.853231069 +0.853742274 +0.854252819 +0.854762702 +0.85527192 +0.855780473 +0.856288359 +0.856795576 +0.857302122 +0.857807997 +0.858313199 +0.858817726 +0.859321576 +0.859824749 +0.860327242 +0.860829054 +0.861330183 +0.861830628 +0.862330388 +0.862829461 +0.863327844 +0.863825538 +0.86432254 +0.864818849 +0.865314463 +0.86580938 +0.8663036 +0.866797121 +0.867289941 +0.867782058 +0.868273471 +0.86876418 +0.869254181 +0.869743474 +0.870232056 +0.870719928 +0.871207087 +0.871693531 +0.872179259 +0.87266427 +0.873148562 +0.873632133 +0.874114983 +0.874597109 +0.87507851 +0.875559185 +0.876039132 +0.87651835 +0.876996837 +0.877474591 +0.877951612 +0.878427898 +0.878903446 +0.879378257 +0.879852327 +0.880325657 +0.880798244 +0.881270087 +0.881741184 +0.882211534 +0.882681136 +0.883149987 +0.883618088 +0.884085435 +0.884552028 +0.885017865 +0.885482945 +0.885947266 +0.886410827 +0.886873627 +0.887335663 +0.887796935 +0.888257441 +0.888717179 +0.889176149 +0.889634348 +0.890091776 +0.890548431 +0.891004311 +0.891459415 +0.891913741 +0.892367289 +0.892820057 +0.893272042 +0.893723245 +0.894173663 +0.894623296 +0.895072141 +0.895520197 +0.895967463 +0.896413937 +0.896859619 +0.897304506 +0.897748597 +0.898191891 +0.898634386 +0.899076082 +0.899516976 +0.899957067 +0.900396354 +0.900834836 +0.90127251 +0.901709377 +0.902145433 +0.902580679 +0.903015112 +0.903448731 +0.903881536 +0.904313523 +0.904744693 +0.905175043 +0.905604572 +0.90603328 +0.906461164 +0.906888223 +0.907314457 +0.907739863 +0.90816444 +0.908588186 +0.909011102 +0.909433184 +0.909854432 +0.910274845 +0.910694421 +0.911113159 +0.911531057 +0.911948114 +0.912364329 +0.9127797 +0.913194227 +0.913607907 +0.91402074 +0.914432724 +0.914843858 +0.915254141 +0.915663571 +0.916072146 +0.916479867 +0.91688673 +0.917292736 +0.917697882 +0.918102168 +0.918505592 +0.918908152 +0.919309849 +0.919710679 +0.920110643 +0.920509738 +0.920907963 +0.921305318 +0.921701801 +0.92209741 +0.922492144 +0.922886003 +0.923278984 +0.923671087 +0.92406231 +0.924452651 +0.924842111 +0.925230687 +0.925618379 +0.926005184 +0.926391102 +0.926776132 +0.927160272 +0.927543521 +0.927925877 +0.92830734 +0.928687909 +0.929067582 +0.929446357 +0.929824234 +0.930201211 +0.930577288 +0.930952463 +0.931326734 +0.931700101 +0.932072562 +0.932444117 +0.932814763 +0.9331845 +0.933553327 +0.933921241 +0.934288244 +0.934654332 +0.935019504 +0.935383761 +0.935747099 +0.936109519 +0.936471019 +0.936831598 +0.937191255 +0.937549988 +0.937907797 +0.938264679 +0.938620635 +0.938975663 +0.939329761 +0.939682929 +0.940035165 +0.940386469 +0.940736839 +0.941086273 +0.941434772 +0.941782333 +0.942128956 +0.94247464 +0.942819382 +0.943163183 +0.943506041 +0.943847955 +0.944188924 +0.944528946 +0.944868022 +0.945206148 +0.945543325 +0.945879552 +0.946214826 +0.946549148 +0.946882516 +0.947214928 +0.947546385 +0.947876884 +0.948206425 +0.948535006 +0.948862627 +0.949189286 +0.949514983 +0.949839716 +0.950163484 +0.950486287 +0.950808122 +0.95112899 +0.951448889 +0.951767817 +0.952085775 +0.95240276 +0.952718772 +0.95303381 +0.953347873 +0.953660959 +0.953973068 +0.954284199 +0.95459435 +0.954903521 +0.955211711 +0.955518918 +0.955825141 +0.956130381 +0.956434634 +0.956737902 +0.957040182 +0.957341473 +0.957641775 +0.957941087 +0.958239407 +0.958536734 +0.958833069 +0.959128409 +0.959422753 +0.959716102 +0.960008453 +0.960299806 +0.960590159 +0.960879513 +0.961167865 +0.961455215 +0.961741562 +0.962026906 +0.962311244 +0.962594576 +0.962876902 +0.96315822 +0.963438529 +0.963717829 +0.963996118 +0.964273395 +0.964549661 +0.964824913 +0.965099151 +0.965372373 +0.96564458 +0.96591577 +0.966185942 +0.966455095 +0.966723229 +0.966990342 +0.967256434 +0.967521504 +0.96778555 +0.968048573 +0.96831057 +0.968571542 +0.968831487 +0.969090405 +0.969348294 +0.969605155 +0.969860985 +0.970115784 +0.970369551 +0.970622286 +0.970873987 +0.971124654 +0.971374286 +0.971622882 +0.971870441 +0.972116963 +0.972362446 +0.97260689 +0.972850294 +0.973092657 +0.973333978 +0.973574257 +0.973813492 +0.974051684 +0.97428883 +0.974524931 +0.974759986 +0.974993993 +0.975226952 +0.975458862 +0.975689723 +0.975919533 +0.976148293 +0.976376 +0.976602655 +0.976828256 +0.977052803 +0.977276296 +0.977498732 +0.977720112 +0.977940435 +0.978159701 +0.978377907 +0.978595055 +0.978811142 +0.979026168 +0.979240133 +0.979453036 +0.979664875 +0.979875651 +0.980085363 +0.98029401 +0.980501591 +0.980708105 +0.980913553 +0.981117932 +0.981321243 +0.981523485 +0.981724657 +0.981924758 +0.982123788 +0.982321746 +0.982518632 +0.982714444 +0.982909183 +0.983102847 +0.983295435 +0.983486948 +0.983677385 +0.983866744 +0.984055026 +0.984242229 +0.984428354 +0.984613398 +0.984797362 +0.984980246 +0.985162048 +0.985342768 +0.985522405 +0.985700959 +0.985878429 +0.986054814 +0.986230115 +0.986404329 +0.986577458 +0.986749499 +0.986920453 +0.987090319 +0.987259097 +0.987426785 +0.987593384 +0.987758892 +0.987923309 +0.988086635 +0.98824887 +0.988410011 +0.98857006 +0.988729015 +0.988886876 +0.989043642 +0.989199313 +0.989353888 +0.989507367 +0.98965975 +0.989811035 +0.989961222 +0.990110311 +0.990258302 +0.990405193 +0.990550984 +0.990695675 +0.990839266 +0.990981755 +0.991123142 +0.991263427 +0.99140261 +0.991540689 +0.991677665 +0.991813537 +0.991948304 +0.992081966 +0.992214523 +0.992345974 +0.992476319 +0.992605556 +0.992733687 +0.99286071 +0.992986625 +0.993111431 +0.993235129 +0.993357717 +0.993479196 +0.993599564 +0.993718822 +0.993836969 +0.993954004 +0.994069928 +0.99418474 +0.994298439 +0.994411025 +0.994522497 +0.994632857 +0.994742102 +0.994850232 +0.994957248 +0.995063149 +0.995167934 +0.995271603 +0.995374157 +0.995475593 +0.995575913 +0.995675115 +0.9957732 +0.995870167 +0.995966015 +0.996060746 +0.996154357 +0.996246849 +0.996338221 +0.996428474 +0.996517606 +0.996605618 +0.99669251 +0.99677828 +0.996862929 +0.996946456 +0.997028862 +0.997110145 +0.997190306 +0.997269344 +0.997347259 +0.997424051 +0.99749972 +0.997574264 +0.997647685 +0.997719981 +0.997791153 +0.9978612 +0.997930122 +0.997997919 +0.998064591 +0.998130136 +0.998194556 +0.99825785 +0.998320017 +0.998381058 +0.998440972 +0.998499759 +0.998557419 +0.998613952 +0.998669357 +0.998723634 +0.998776783 +0.998828805 +0.998879698 +0.998929462 +0.998978098 +0.999025605 +0.999071983 +0.999117233 +0.999161352 +0.999204343 +0.999246204 +0.999286935 +0.999326536 +0.999365008 +0.999402349 +0.99943856 +0.999473641 +0.999507591 +0.999540411 +0.9995721 +0.999602658 +0.999632085 +0.999660382 +0.999687547 +0.999713581 +0.999738484 +0.999762255 +0.999784895 +0.999806403 +0.99982678 +0.999846025 +0.999864139 +0.999881121 +0.99989697 +0.999911688 +0.999925274 +0.999937728 +0.99994905 +0.99995924 +0.999968297 +0.999976223 +0.999983016 +0.999988678 +0.999993207 +0.999996603 +0.999998868 +1 +1 +0.999998868 +0.999996603 +0.999993207 +0.999988678 +0.999983016 +0.999976223 +0.999968297 +0.99995924 +0.99994905 +0.999937728 +0.999925274 +0.999911688 +0.99989697 +0.999881121 +0.999864139 +0.999846025 +0.99982678 +0.999806403 +0.999784895 +0.999762255 +0.999738484 +0.999713581 +0.999687547 +0.999660382 +0.999632085 +0.999602658 +0.9995721 +0.999540411 +0.999507591 +0.999473641 +0.99943856 +0.999402349 +0.999365008 +0.999326536 +0.999286935 +0.999246204 +0.999204343 +0.999161352 +0.999117233 +0.999071983 +0.999025605 +0.998978098 +0.998929462 +0.998879698 +0.998828805 +0.998776783 +0.998723634 +0.998669357 +0.998613952 +0.998557419 +0.998499759 +0.998440972 +0.998381058 +0.998320017 +0.99825785 +0.998194556 +0.998130136 +0.998064591 +0.997997919 +0.997930122 +0.9978612 +0.997791153 +0.997719981 +0.997647685 +0.997574264 +0.99749972 +0.997424051 +0.997347259 +0.997269344 +0.997190306 +0.997110145 +0.997028862 +0.996946456 +0.996862929 +0.99677828 +0.99669251 +0.996605618 +0.996517606 +0.996428474 +0.996338221 +0.996246849 +0.996154357 +0.996060746 +0.995966015 +0.995870167 +0.9957732 +0.995675115 +0.995575913 +0.995475593 +0.995374157 +0.995271603 +0.995167934 +0.995063149 +0.994957248 +0.994850232 +0.994742102 +0.994632857 +0.994522497 +0.994411025 +0.994298439 +0.99418474 +0.994069928 +0.993954004 +0.993836969 +0.993718822 +0.993599564 +0.993479196 +0.993357717 +0.993235129 +0.993111431 +0.992986625 +0.99286071 +0.992733687 +0.992605556 +0.992476319 +0.992345974 +0.992214523 +0.992081966 +0.991948304 +0.991813537 +0.991677665 +0.991540689 +0.99140261 +0.991263427 +0.991123142 +0.990981755 +0.990839266 +0.990695675 +0.990550984 +0.990405193 +0.990258302 +0.990110311 +0.989961222 +0.989811035 +0.98965975 +0.989507367 +0.989353888 +0.989199313 +0.989043642 +0.988886876 +0.988729015 +0.98857006 +0.988410011 +0.98824887 +0.988086635 +0.987923309 +0.987758892 +0.987593384 +0.987426785 +0.987259097 +0.987090319 +0.986920453 +0.986749499 +0.986577458 +0.986404329 +0.986230115 +0.986054814 +0.985878429 +0.985700959 +0.985522405 +0.985342768 +0.985162048 +0.984980246 +0.984797362 +0.984613398 +0.984428354 +0.984242229 +0.984055026 +0.983866744 +0.983677385 +0.983486948 +0.983295435 +0.983102847 +0.982909183 +0.982714444 +0.982518632 +0.982321746 +0.982123788 +0.981924758 +0.981724657 +0.981523485 +0.981321243 +0.981117932 +0.980913553 +0.980708105 +0.980501591 +0.98029401 +0.980085363 +0.979875651 +0.979664875 +0.979453036 +0.979240133 +0.979026168 +0.978811142 +0.978595055 +0.978377907 +0.978159701 +0.977940435 +0.977720112 +0.977498732 +0.977276296 +0.977052803 +0.976828256 +0.976602655 +0.976376 +0.976148293 +0.975919533 +0.975689723 +0.975458862 +0.975226952 +0.974993993 +0.974759986 +0.974524931 +0.97428883 +0.974051684 +0.973813492 +0.973574257 +0.973333978 +0.973092657 +0.972850294 +0.97260689 +0.972362446 +0.972116963 +0.971870441 +0.971622882 +0.971374286 +0.971124654 +0.970873987 +0.970622286 +0.970369551 +0.970115784 +0.969860985 +0.969605155 +0.969348294 +0.969090405 +0.968831487 +0.968571542 +0.96831057 +0.968048573 +0.96778555 +0.967521504 +0.967256434 +0.966990342 +0.966723229 +0.966455095 +0.966185942 +0.96591577 +0.96564458 +0.965372373 +0.965099151 +0.964824913 +0.964549661 +0.964273395 +0.963996118 +0.963717829 +0.963438529 +0.96315822 +0.962876902 +0.962594576 +0.962311244 +0.962026906 +0.961741562 +0.961455215 +0.961167865 +0.960879513 +0.960590159 +0.960299806 +0.960008453 +0.959716102 +0.959422753 +0.959128409 +0.958833069 +0.958536734 +0.958239407 +0.957941087 +0.957641775 +0.957341473 +0.957040182 +0.956737902 +0.956434634 +0.956130381 +0.955825141 +0.955518918 +0.955211711 +0.954903521 +0.95459435 +0.954284199 +0.953973068 +0.953660959 +0.953347873 +0.95303381 +0.952718772 +0.95240276 +0.952085775 +0.951767817 +0.951448889 +0.95112899 +0.950808122 +0.950486287 +0.950163484 +0.949839716 +0.949514983 +0.949189286 +0.948862627 +0.948535006 +0.948206425 +0.947876884 +0.947546385 +0.947214928 +0.946882516 +0.946549148 +0.946214826 +0.945879552 +0.945543325 +0.945206148 +0.944868022 +0.944528946 +0.944188924 +0.943847955 +0.943506041 +0.943163183 +0.942819382 +0.94247464 +0.942128956 +0.941782333 +0.941434772 +0.941086273 +0.940736839 +0.940386469 +0.940035165 +0.939682929 +0.939329761 +0.938975663 +0.938620635 +0.938264679 +0.937907797 +0.937549988 +0.937191255 +0.936831598 +0.936471019 +0.936109519 +0.935747099 +0.935383761 +0.935019504 +0.934654332 +0.934288244 +0.933921241 +0.933553327 +0.9331845 +0.932814763 +0.932444117 +0.932072562 +0.931700101 +0.931326734 +0.930952463 +0.930577288 +0.930201211 +0.929824234 +0.929446357 +0.929067582 +0.928687909 +0.92830734 +0.927925877 +0.927543521 +0.927160272 +0.926776132 +0.926391102 +0.926005184 +0.925618379 +0.925230687 +0.924842111 +0.924452651 +0.92406231 +0.923671087 +0.923278984 +0.922886003 +0.922492144 +0.92209741 +0.921701801 +0.921305318 +0.920907963 +0.920509738 +0.920110643 +0.919710679 +0.919309849 +0.918908152 +0.918505592 +0.918102168 +0.917697882 +0.917292736 +0.91688673 +0.916479867 +0.916072146 +0.915663571 +0.915254141 +0.914843858 +0.914432724 +0.91402074 +0.913607907 +0.913194227 +0.9127797 +0.912364329 +0.911948114 +0.911531057 +0.911113159 +0.910694421 +0.910274845 +0.909854432 +0.909433184 +0.909011102 +0.908588186 +0.90816444 +0.907739863 +0.907314457 +0.906888223 +0.906461164 +0.90603328 +0.905604572 +0.905175043 +0.904744693 +0.904313523 +0.903881536 +0.903448731 +0.903015112 +0.902580679 +0.902145433 +0.901709377 +0.90127251 +0.900834836 +0.900396354 +0.899957067 +0.899516976 +0.899076082 +0.898634386 +0.898191891 +0.897748597 +0.897304506 +0.896859619 +0.896413937 +0.895967463 +0.895520197 +0.895072141 +0.894623296 +0.894173663 +0.893723245 +0.893272042 +0.892820057 +0.892367289 +0.891913741 +0.891459415 +0.891004311 +0.890548431 +0.890091776 +0.889634348 +0.889176149 +0.888717179 +0.888257441 +0.887796935 +0.887335663 +0.886873627 +0.886410827 +0.885947266 +0.885482945 +0.885017865 +0.884552028 +0.884085435 +0.883618088 +0.883149987 +0.882681136 +0.882211534 +0.881741184 +0.881270087 +0.880798244 +0.880325657 +0.879852327 +0.879378257 +0.878903446 +0.878427898 +0.877951612 +0.877474591 +0.876996837 +0.87651835 +0.876039132 +0.875559185 +0.87507851 +0.874597109 +0.874114983 +0.873632133 +0.873148562 +0.87266427 +0.872179259 +0.871693531 +0.871207087 +0.870719928 +0.870232056 +0.869743474 +0.869254181 +0.86876418 +0.868273471 +0.867782058 +0.867289941 +0.866797121 +0.8663036 +0.86580938 +0.865314463 +0.864818849 +0.86432254 +0.863825538 +0.863327844 +0.862829461 +0.862330388 +0.861830628 +0.861330183 +0.860829054 +0.860327242 +0.859824749 +0.859321576 +0.858817726 +0.858313199 +0.857807997 +0.857302122 +0.856795576 +0.856288359 +0.855780473 +0.85527192 +0.854762702 +0.854252819 +0.853742274 +0.853231069 +0.852719203 +0.85220668 +0.851693501 +0.851179667 +0.850665179 +0.85015004 +0.849634251 +0.849117814 +0.84860073 +0.848083 +0.847564626 +0.84704561 +0.846525954 +0.846005659 +0.845484726 +0.844963157 +0.844440953 +0.843918117 +0.84339465 +0.842870553 +0.842345828 +0.841820476 +0.8412945 +0.8407679 +0.840240678 +0.839712837 +0.839184376 +0.838655299 +0.838125606 +0.8375953 +0.837064381 +0.836532852 +0.836000713 +0.835467968 +0.834934616 +0.83440066 +0.833866101 +0.833330941 +0.832795182 +0.832258825 +0.831721872 +0.831184324 +0.830646183 +0.83010745 +0.829568127 +0.829028217 +0.828487719 +0.827946637 +0.827404971 +0.826862723 +0.826319895 +0.825776488 +0.825232505 +0.824687945 +0.824142813 +0.823597108 +0.823050832 +0.822503987 +0.821956575 +0.821408598 +0.820860056 +0.820310952 +0.819761287 +0.819211063 +0.818660281 +0.818108943 +0.81755705 +0.817004605 +0.816451609 +0.815898064 +0.81534397 +0.81478933 +0.814234146 +0.813678418 +0.81312215 +0.812565341 +0.812007994 +0.811450111 +0.810891693 +0.810332742 +0.809773259 +0.809213247 +0.808652706 +0.808091638 +0.807530045 +0.806967929 +0.806405291 +0.805842133 +0.805278456 +0.804714263 +0.804149554 +0.803584332 +0.803018598 +0.802452354 +0.801885601 +0.80131834 +0.800750575 +0.800182306 +0.799613535 +0.799044263 +0.798474492 +0.797904225 +0.797333462 +0.796762205 +0.796190455 +0.795618216 +0.795045487 +0.794472271 +0.793898569 +0.793324384 +0.792749716 +0.792174568 +0.79159894 +0.791022835 +0.790446255 +0.7898692 +0.789291673 +0.788713675 +0.788135208 +0.787556274 +0.786976874 +0.786397009 +0.785816682 +0.785235895 +0.784654648 +0.784072944 +0.783490784 +0.782908169 +0.782325102 +0.781741585 +0.781157617 +0.780573203 +0.779988342 +0.779403037 +0.77881729 +0.778231102 +0.777644474 +0.777057409 +0.776469907 +0.775881972 +0.775293604 +0.774704804 +0.774115576 +0.77352592 +0.772935838 +0.772345331 +0.771754402 +0.771163051 +0.770571282 +0.769979094 +0.769386491 +0.768793473 +0.768200043 +0.767606201 +0.76701195 +0.766417292 +0.765822227 +0.765226758 +0.764630886 +0.764034613 +0.763437941 +0.76284087 +0.762243404 +0.761645543 +0.76104729 +0.760448645 +0.759849611 +0.75925019 +0.758650382 +0.758050189 +0.757449614 +0.756848658 +0.756247322 +0.755645609 +0.755043519 +0.754441055 +0.753838218 +0.75323501 +0.752631432 +0.752027486 +0.751423175 +0.750818499 +0.75021346 +0.749608059 +0.7490023 +0.748396182 +0.747789708 +0.74718288 +0.746575699 +0.745968167 +0.745360285 +0.744752055 +0.744143479 +0.743534558 +0.742925295 +0.74231569 +0.741705745 +0.741095463 +0.740484844 +0.739873891 +0.739262605 +0.738650988 +0.738039041 +0.737426766 +0.736814164 +0.736201238 +0.735587989 +0.734974419 +0.734360529 +0.733746321 +0.733131796 +0.732516957 +0.731901805 +0.731286341 +0.730670568 +0.730054486 +0.729438098 +0.728821405 +0.728204409 +0.727587112 +0.726969515 +0.726351619 +0.725733427 +0.725114941 +0.724496161 +0.723877089 +0.723257727 +0.722638078 +0.722018141 +0.72139792 +0.720777415 +0.720156629 +0.719535562 +0.718914217 +0.718292596 +0.717670699 +0.717048529 +0.716426087 +0.715803375 +0.715180395 +0.714557147 +0.713933635 +0.713309859 +0.71268582 +0.712061522 +0.711436965 +0.710812151 +0.710187081 +0.709561758 +0.708936183 +0.708310357 +0.707684282 +0.707057961 +0.706431393 +0.705804582 +0.705177529 +0.704550234 +0.703922701 +0.703294931 +0.702666924 +0.702038684 +0.701410211 +0.700781508 +0.700152575 +0.699523414 +0.698894028 +0.698264417 +0.697634583 +0.697004529 +0.696374255 +0.695743763 +0.695113055 +0.694482132 +0.693850997 +0.69321965 +0.692588093 +0.691956328 +0.691324357 +0.690692181 +0.690059802 +0.689427221 +0.68879444 +0.688161461 +0.687528285 +0.686894914 +0.686261349 +0.685627592 +0.684993645 +0.684359509 +0.683725187 +0.683090678 +0.682455986 +0.681821112 +0.681186057 +0.680550823 +0.679915411 +0.679279823 +0.678644062 +0.678008127 +0.677372022 +0.676735747 +0.676099304 +0.675462696 +0.674825922 +0.674188985 +0.673551887 +0.672914629 +0.672277213 +0.67163964 +0.671001912 +0.670364031 +0.669725997 +0.669087814 +0.668449481 +0.667811002 +0.667172377 +0.666533607 +0.665894696 +0.665255644 +0.664616452 +0.663977123 +0.663337658 +0.662698058 +0.662058326 +0.661418462 +0.660778468 +0.660138346 +0.659498098 +0.658857724 +0.658217227 +0.657576608 +0.656935869 +0.656295011 +0.655654036 +0.655012945 +0.65437174 +0.653730423 +0.653088995 +0.652447457 +0.651805812 +0.65116406 +0.650522203 +0.649880244 +0.649238183 +0.648596021 +0.647953762 +0.647311405 +0.646668953 +0.646026407 +0.645383769 +0.64474104 +0.644098222 +0.643455316 +0.642812324 +0.642169248 +0.641526088 +0.640882848 +0.640239527 +0.639596127 +0.638952651 +0.6383091 +0.637665474 +0.637021777 +0.636378008 +0.635734171 +0.635090265 +0.634446294 +0.633802258 +0.633158158 +0.632513997 +0.631869776 +0.631225497 +0.63058116 +0.629936768 +0.629292322 +0.628647824 +0.628003274 +0.627358675 +0.626714028 +0.626069334 +0.625424596 +0.624779814 +0.62413499 +0.623490126 +0.622845223 +0.622200282 +0.621555306 +0.620910295 +0.620265251 +0.619620175 +0.61897507 +0.618329936 +0.617684775 +0.617039589 +0.616394379 +0.615749146 +0.615103892 +0.614458618 +0.613813327 +0.613168019 +0.612522696 +0.611877359 +0.61123201 +0.61058665 +0.609941281 +0.609295905 +0.608650522 +0.608005134 +0.607359743 +0.60671435 +0.606068957 +0.605423564 +0.604778175 +0.604132789 +0.603487408 +0.602842035 +0.60219667 +0.601551314 +0.60090597 +0.600260638 +0.599615321 +0.598970019 +0.598324734 +0.597679468 +0.597034222 +0.596388996 +0.595743794 +0.595098616 +0.594453463 +0.593808338 +0.593163241 +0.592518174 +0.591873138 +0.591228136 +0.590583167 +0.589938234 +0.589293338 +0.588648481 +0.588003663 +0.587358887 +0.586714153 +0.586069464 +0.58542482 +0.584780223 +0.584135674 +0.583491176 +0.582846728 +0.582202333 +0.581557992 +0.580913706 +0.580269477 +0.579625306 +0.578981195 +0.578337145 +0.577693157 +0.577049233 +0.576405374 +0.575761581 +0.575117856 +0.574474201 +0.573830616 +0.573187103 +0.572543664 +0.571900299 +0.571257011 +0.5706138 +0.569970667 +0.569327616 +0.568684645 +0.568041758 +0.567398955 +0.566756238 +0.566113608 +0.565471066 +0.564828614 +0.564186253 +0.563543984 +0.562901809 +0.56225973 +0.561617747 +0.560975862 +0.560334076 +0.55969239 +0.559050807 +0.558409326 +0.55776795 +0.55712668 +0.556485517 +0.555844463 +0.555203519 +0.554562685 +0.553921964 +0.553281357 +0.552640866 +0.55200049 +0.551360232 +0.550720094 +0.550080076 +0.549440179 +0.548800406 +0.548160756 +0.547521233 +0.546881836 +0.546242567 +0.545603428 +0.54496442 +0.544325544 +0.543686801 +0.543048193 +0.542409721 +0.541771386 +0.54113319 +0.540495133 +0.539857218 +0.539219445 +0.538581815 +0.53794433 +0.537306992 +0.536669801 +0.536032759 +0.535395867 +0.534759126 +0.534122537 +0.533486102 +0.532849823 +0.532213699 +0.531577734 +0.530941926 +0.530306279 +0.529670794 +0.52903547 +0.528400311 +0.527765316 +0.527130488 +0.526495827 +0.525861335 +0.525227013 +0.524592862 +0.523958884 +0.523325079 +0.522691449 +0.522057995 +0.521424718 +0.52079162 +0.520158702 +0.519525964 +0.518893409 +0.518261037 +0.51762885 +0.516996849 +0.516365034 +0.515733408 +0.515101971 +0.514470724 +0.51383967 +0.513208808 +0.512578141 +0.511947669 +0.511317393 +0.510687315 +0.510057437 +0.509427758 +0.50879828 +0.508169005 +0.507539934 +0.506911067 +0.506282406 +0.505653952 +0.505025707 +0.504397671 +0.503769846 +0.503142232 +0.502514832 +0.501887645 +0.501260674 +0.500633919 +0.500007382 +0.499381063 +0.498754964 +0.498129087 +0.497503431 +0.496877998 +0.49625279 +0.495627807 +0.495003051 +0.494378523 +0.493754224 +0.493130154 +0.492506316 +0.49188271 +0.491259338 +0.4906362 +0.490013297 +0.489390631 +0.488768203 +0.488146014 +0.487524065 +0.486902357 +0.486280892 +0.485659669 +0.485038692 +0.484417959 +0.483797473 +0.483177235 +0.482557246 +0.481937507 +0.481318018 +0.480698782 +0.480079798 +0.479461069 +0.478842595 +0.478224378 +0.477606417 +0.476988716 +0.476371273 +0.475754092 +0.475137172 +0.474520514 +0.473904121 +0.473287992 +0.472672129 +0.472056533 +0.471441205 +0.470826146 +0.470211357 +0.469596839 +0.468982593 +0.46836862 +0.467754921 +0.467141498 +0.466528351 +0.465915481 +0.465302889 +0.464690577 +0.464078545 +0.463466794 +0.462855326 +0.462244141 +0.46163324 +0.461022625 +0.460412296 +0.459802255 +0.459192501 +0.458583038 +0.457973864 +0.457364982 +0.456756392 +0.456148096 +0.455540094 +0.454932387 +0.454324977 +0.453717864 +0.453111049 +0.452504533 +0.451898318 +0.451292404 +0.450686791 +0.450081482 +0.449476477 +0.448871777 +0.448267383 +0.447663296 +0.447059517 +0.446456046 +0.445852886 +0.445250036 +0.444647498 +0.444045272 +0.44344336 +0.442841763 +0.442240481 +0.441639515 +0.441038866 +0.440438536 +0.439838525 +0.439238834 +0.438639464 +0.438040416 +0.437441691 +0.436843289 +0.436245212 +0.435647461 +0.435050036 +0.434452938 +0.433856169 +0.433259729 +0.432663619 +0.43206784 +0.431472393 +0.430877278 +0.430282498 +0.429688051 +0.42909394 +0.428500166 +0.427906728 +0.427313629 +0.426720868 +0.426128448 +0.425536367 +0.424944629 +0.424353233 +0.42376218 +0.423171471 +0.422581107 +0.421991089 +0.421401417 +0.420812093 +0.420223118 +0.419634492 +0.419046215 +0.41845829 +0.417870716 +0.417283495 +0.416696627 +0.416110114 +0.415523955 +0.414938153 +0.414352707 +0.413767619 +0.413182889 +0.412598518 +0.412014507 +0.411430857 +0.410847569 +0.410264643 +0.40968208 +0.409099881 +0.408518047 +0.407936579 +0.407355477 +0.406774742 +0.406194375 +0.405614377 +0.405034749 +0.404455491 +0.403876604 +0.403298089 +0.402719947 +0.402142178 +0.401564783 +0.400987764 +0.40041112 +0.399834852 +0.399258962 +0.39868345 +0.398108317 +0.397533564 +0.39695919 +0.396385198 +0.395811588 +0.39523836 +0.394665515 +0.394093055 +0.393520979 +0.392949289 +0.392377985 +0.391807068 +0.391236539 +0.390666398 +0.390096647 +0.389527285 +0.388958314 +0.388389734 +0.387821546 +0.387253751 +0.38668635 +0.386119342 +0.38555273 +0.384986513 +0.384420692 +0.383855269 +0.383290243 +0.382725615 +0.382161387 +0.381597558 +0.381034129 +0.380471102 +0.379908476 +0.379346253 +0.378784434 +0.378223017 +0.377662006 +0.3771014 +0.376541199 +0.375981405 +0.375422018 +0.374863039 +0.374304468 +0.373746307 +0.373188555 +0.372631214 +0.372074284 +0.371517765 +0.370961659 +0.370405966 +0.369850687 +0.369295821 +0.368741371 +0.368187337 +0.367633718 +0.367080516 +0.366527732 +0.365975366 +0.365423419 +0.36487189 +0.364320782 +0.363770094 +0.363219828 +0.362669983 +0.36212056 +0.361571561 +0.361022985 +0.360474833 +0.359927106 +0.359379804 +0.358832928 +0.358286479 +0.357740456 +0.357194862 +0.356649695 +0.356104958 +0.35556065 +0.355016772 +0.354473325 +0.353930308 +0.353387724 +0.352845572 +0.352303852 +0.351762566 +0.351221714 +0.350681297 +0.350141314 +0.349601768 +0.349062657 +0.348523983 +0.347985747 +0.347447948 +0.346910587 +0.346373666 +0.345837184 +0.345301142 +0.34476554 +0.344230379 +0.34369566 +0.343161383 +0.342627549 +0.342094158 +0.34156121 +0.341028707 +0.340496648 +0.339965034 +0.339433866 +0.338903144 +0.338372869 +0.337843041 +0.337313661 +0.336784729 +0.336256246 +0.335728211 +0.335200627 +0.334673492 +0.334146809 +0.333620576 +0.333094795 +0.332569466 +0.332044589 +0.331520166 +0.330996196 +0.33047268 +0.329949618 +0.329427012 +0.32890486 +0.328383165 +0.327861926 +0.327341143 +0.326820818 +0.32630095 +0.32578154 +0.325262589 +0.324744097 +0.324226064 +0.323708491 +0.323191379 +0.322674727 +0.322158536 +0.321642807 +0.32112754 +0.320612735 +0.320098393 +0.319584515 +0.3190711 +0.318558149 +0.318045663 +0.317533642 +0.317022086 +0.316510996 +0.316000372 +0.315490214 +0.314980524 +0.314471301 +0.313962545 +0.313454258 +0.312946439 +0.31243909 +0.311932209 +0.311425799 +0.310919858 +0.310414388 +0.309909389 +0.309404861 +0.308900805 +0.30839722 +0.307894108 +0.307391469 +0.306889303 +0.30638761 +0.305886391 +0.305385646 +0.304885376 +0.304385581 +0.303886261 +0.303387416 +0.302889047 +0.302391155 +0.301893739 +0.301396801 +0.300900339 +0.300404355 +0.299908849 +0.299413822 +0.298919273 +0.298425203 +0.297931612 +0.297438501 +0.29694587 +0.296453719 +0.295962049 +0.29547086 +0.294980152 +0.294489925 +0.29400018 +0.293510917 +0.293022137 +0.29253384 +0.292046025 +0.291558694 +0.291071846 +0.290585483 +0.290099604 +0.289614209 +0.289129299 +0.288644874 +0.288160934 +0.28767748 +0.287194512 +0.28671203 +0.286230035 +0.285748526 +0.285267504 +0.28478697 +0.284306923 +0.283827364 +0.283348293 +0.282869711 +0.282391617 +0.281914012 +0.281436896 +0.280960269 +0.280484132 +0.280008485 +0.279533328 +0.279058662 +0.278584485 +0.2781108 +0.277637606 +0.277164903 +0.276692692 +0.276220972 +0.275749744 +0.275279009 +0.274808766 +0.274339016 +0.273869758 +0.273400994 +0.272932723 +0.272464946 +0.271997662 +0.271530872 +0.271064577 +0.270598776 +0.270133469 +0.269668657 +0.26920434 +0.268740519 +0.268277192 +0.267814362 +0.267352027 +0.266890188 +0.266428845 +0.265967998 +0.265507648 +0.265047795 +0.264588439 +0.264129579 +0.263671217 +0.263213352 +0.262755985 +0.262299116 +0.261842744 +0.261386871 +0.260931496 +0.260476619 +0.260022241 +0.259568361 +0.25911498 +0.258662099 +0.258209716 +0.257757833 +0.25730645 +0.256855566 +0.256405182 +0.255955298 +0.255505913 +0.255057029 +0.254608646 +0.254160763 +0.25371338 +0.253266498 +0.252820117 +0.252374237 +0.251928858 +0.251483981 +0.251039605 +0.25059573 +0.250152357 +0.249709485 +0.249267116 +0.248825248 +0.248383882 +0.247943019 +0.247502658 +0.247062799 +0.246623442 +0.246184589 +0.245746238 +0.245308389 +0.244871044 +0.244434201 +0.243997862 +0.243562025 +0.243126692 +0.242691862 +0.242257536 +0.241823713 +0.241390394 +0.240957578 +0.240525266 +0.240093458 +0.239662153 +0.239231353 +0.238801056 +0.238371264 +0.237941975 +0.237513191 +0.237084911 +0.236657136 +0.236229865 +0.235803098 +0.235376836 +0.234951078 +0.234525825 +0.234101076 +0.233676832 +0.233253093 +0.232829859 +0.232407129 +0.231984905 +0.231563185 +0.23114197 +0.23072126 +0.230301055 +0.229881355 +0.22946216 +0.22904347 +0.228625286 +0.228207606 +0.227790432 +0.227373762 +0.226957598 +0.22654194 +0.226126786 +0.225712137 +0.225297994 +0.224884356 +0.224471224 +0.224058596 +0.223646474 +0.223234858 +0.222823746 +0.22241314 +0.222003039 +0.221593443 +0.221184353 +0.220775767 +0.220367688 +0.219960113 +0.219553043 +0.219146479 +0.21874042 +0.218334866 +0.217929818 +0.217525274 +0.217121236 +0.216717702 +0.216314674 +0.215912151 +0.215510132 +0.215108619 +0.214707611 +0.214307108 +0.213907109 +0.213507615 +0.213108627 +0.212710142 +0.212312163 +0.211914688 +0.211517718 +0.211121253 +0.210725292 +0.210329835 +0.209934883 +0.209540436 +0.209146492 +0.208753053 +0.208360118 +0.207967688 +0.207575761 +0.207184338 +0.20679342 +0.206403005 +0.206013094 +0.205623687 +0.205234783 +0.204846384 +0.204458487 +0.204071094 +0.203684205 +0.203297819 +0.202911936 +0.202526556 +0.202141679 +0.201757305 +0.201373434 +0.200990066 +0.200607201 +0.200224838 +0.199842977 +0.19946162 +0.199080764 +0.198700411 +0.19832056 +0.19794121 +0.197562363 +0.197184018 +0.196806174 +0.196428832 +0.196051992 +0.195675652 +0.195299815 +0.194924478 +0.194549642 +0.194175308 +0.193801474 +0.193428141 +0.193055308 +0.192682976 +0.192311144 +0.191939813 +0.191568981 +0.19119865 +0.190828818 +0.190459486 +0.190090654 +0.189722321 +0.189354488 +0.188987153 +0.188620318 +0.188253981 +0.187888144 +0.187522805 +0.187157964 +0.186793622 +0.186429778 +0.186066431 +0.185703583 +0.185341233 +0.18497938 +0.184618025 +0.184257166 +0.183896805 +0.183536941 +0.183177574 +0.182818704 +0.182460329 +0.182102452 +0.18174507 +0.181388184 +0.181031795 +0.1806759 +0.180320502 +0.179965598 +0.17961119 +0.179257277 +0.178903859 +0.178550935 +0.178198506 +0.17784657 +0.177495129 +0.177144182 +0.176793729 +0.176443769 +0.176094303 +0.17574533 +0.175396849 +0.175048862 +0.174701367 +0.174354364 +0.174007854 +0.173661836 +0.173316309 +0.172971274 +0.172626731 +0.172282679 +0.171939118 +0.171596048 +0.171253468 +0.170911379 +0.17056978 +0.170228671 +0.169888051 +0.169547922 +0.169208282 +0.168869131 +0.168530468 +0.168192295 +0.16785461 +0.167517414 +0.167180705 +0.166844485 +0.166508752 +0.166173506 +0.165838748 +0.165504477 +0.165170692 +0.164837394 +0.164504582 +0.164172257 +0.163840417 +0.163509063 +0.163178194 +0.16284781 +0.162517911 +0.162188497 +0.161859568 +0.161531122 +0.161203161 +0.160875683 +0.160548689 +0.160222177 +0.159896149 +0.159570604 +0.159245541 +0.158920961 +0.158596862 +0.158273245 +0.15795011 +0.157627456 +0.157305283 +0.15698359 +0.156662378 +0.156341647 +0.156021395 +0.155701623 +0.155382331 +0.155063517 +0.154745183 +0.154427327 +0.15410995 +0.153793051 +0.153476629 +0.153160686 +0.152845219 +0.15253023 +0.152215718 +0.151901682 +0.151588122 +0.151275038 +0.15096243 +0.150650297 +0.15033864 +0.150027457 +0.149716749 +0.149406516 +0.149096756 +0.14878747 +0.148478658 +0.148170318 +0.147862452 +0.147555058 +0.147248137 +0.146941687 +0.14663571 +0.146330203 +0.146025168 +0.145720604 +0.145416511 +0.145112887 +0.144809734 +0.144507051 +0.144204836 +0.143903091 +0.143601815 +0.143301007 +0.143000667 +0.142700796 +0.142401392 +0.142102455 +0.141803985 +0.141505982 +0.141208445 +0.140911374 +0.140614769 +0.14031863 +0.140022955 +0.139727746 +0.139433001 +0.13913872 +0.138844903 +0.13855155 +0.13825866 +0.137966233 +0.137674268 +0.137382766 +0.137091725 +0.136801147 +0.13651103 +0.136221373 +0.135932178 +0.135643443 +0.135355168 +0.135067352 +0.134779996 +0.134493099 +0.134206661 +0.133920681 +0.13363516 +0.133350096 +0.133065489 +0.13278134 +0.132497647 +0.132214411 +0.131931631 +0.131649306 +0.131367437 +0.131086023 +0.130805064 +0.130524559 +0.130244509 +0.129964912 +0.129685768 +0.129407078 +0.12912884 +0.128851054 +0.12857372 +0.128296839 +0.128020408 +0.127744428 +0.127468899 +0.127193821 +0.126919192 +0.126645013 +0.126371282 +0.126098001 +0.125825169 +0.125552784 +0.125280847 +0.125009358 +0.124738316 +0.124467721 +0.124197571 +0.123927868 +0.123658611 +0.123389799 +0.123121432 +0.122853509 +0.122586031 +0.122318997 +0.122052406 +0.121786258 +0.121520553 +0.12125529 +0.12099047 +0.120726091 +0.120462153 +0.120198656 +0.1199356 +0.119672984 +0.119410808 +0.119149072 +0.118887774 +0.118626915 +0.118366495 +0.118106513 +0.117846968 +0.11758786 +0.117329189 +0.117070955 +0.116813157 +0.116555794 +0.116298867 +0.116042375 +0.115786317 +0.115530694 +0.115275504 +0.115020748 +0.114766425 +0.114512534 +0.114259076 +0.11400605 +0.113753455 +0.113501292 +0.113249559 +0.112998256 +0.112747384 +0.112496941 +0.112246928 +0.111997343 +0.111748186 +0.111499458 +0.111251157 +0.111003284 +0.110755837 +0.110508817 +0.110262223 +0.110016055 +0.109770312 +0.109524994 +0.1092801 +0.109035631 +0.108791585 +0.108547963 +0.108304763 +0.108061986 +0.107819632 +0.107577698 +0.107336187 +0.107095096 +0.106854426 +0.106614175 +0.106374345 +0.106134934 +0.105895942 +0.105657368 +0.105419213 +0.105181475 +0.104944154 +0.104707251 +0.104470764 +0.104234693 +0.103999038 +0.103763798 +0.103528972 +0.103294562 +0.103060565 +0.102826982 +0.102593813 +0.102361056 +0.102128711 +0.101896779 +0.101665258 +0.101434149 +0.10120345 +0.100973161 +0.100743283 +0.100513814 +0.100284754 +0.100056103 +0.0998278601 +0.0996000252 +0.0993725977 +0.0991455773 +0.0989189635 +0.098692756 +0.0984669542 +0.0982415578 +0.0980165664 +0.0977919795 +0.0975677968 +0.0973440178 +0.097120642 +0.0968976692 +0.0966750987 +0.0964529303 +0.0962311635 +0.0960097979 +0.0957888331 +0.0955682686 +0.095348104 +0.0951283389 +0.0949089729 +0.0946900055 +0.0944714363 +0.094253265 +0.094035491 +0.0938181139 +0.0936011334 +0.0933845489 +0.0931683602 +0.0929525666 +0.0927371679 +0.0925221636 +0.0923075532 +0.0920933363 +0.0918795126 +0.0916660815 +0.0914530426 +0.0912403956 +0.09102814 +0.0908162753 +0.0906048011 +0.090393717 +0.0901830226 +0.0899727173 +0.0897628009 +0.0895532729 +0.0893441328 +0.0891353801 +0.0889270146 +0.0887190356 +0.0885114429 +0.0883042359 +0.0880974142 +0.0878909775 +0.0876849252 +0.0874792569 +0.0872739722 +0.0870690707 +0.0868645518 +0.0866604153 +0.0864566606 +0.0862532873 +0.0860502949 +0.0858476831 +0.0856454514 +0.0854435993 +0.0852421265 +0.0850410324 +0.0848403167 +0.0846399788 +0.0844400185 +0.0842404351 +0.0840412284 +0.0838423977 +0.0836439428 +0.0834458631 +0.0832481583 +0.0830508278 +0.0828538713 +0.0826572883 +0.0824610783 +0.0822652409 +0.0820697758 +0.0818746823 +0.0816799601 +0.0814856088 +0.0812916279 +0.0810980169 +0.0809047754 +0.0807119031 +0.0805193993 +0.0803272637 +0.0801354959 +0.0799440954 +0.0797530617 +0.0795623944 +0.0793720931 +0.0791821573 +0.0789925866 +0.0788033805 +0.0786145386 +0.0784260605 +0.0782379456 +0.0780501935 +0.0778628039 +0.0776757762 +0.07748911 +0.0773028049 +0.0771168604 +0.0769312761 +0.0767460515 +0.0765611861 +0.0763766796 +0.0761925314 +0.0760087412 +0.0758253085 +0.0756422328 +0.0754595137 +0.0752771507 +0.0750951434 +0.0749134914 +0.0747321941 +0.0745512512 +0.0743706622 +0.0741904266 +0.0740105441 +0.073831014 +0.0736518361 +0.0734730098 +0.0732945348 +0.0731164105 +0.0729386365 +0.0727612123 +0.0725841375 +0.0724074117 +0.0722310344 +0.0720550052 +0.0718793235 +0.071703989 +0.0715290013 +0.0713543597 +0.071180064 +0.0710061136 +0.0708325081 +0.0706592471 +0.07048633 +0.0703137566 +0.0701415262 +0.0699696384 +0.0697980929 +0.0696268891 +0.0694560266 +0.0692855049 +0.0691153237 +0.0689454823 +0.0687759805 +0.0686068177 +0.0684379935 +0.0682695074 +0.068101359 +0.0679335479 +0.0677660735 +0.0675989354 +0.0674321333 +0.0672656665 +0.0670995348 +0.0669337375 +0.0667682743 +0.0666031448 +0.0664383484 +0.0662738848 +0.0661097534 +0.0659459538 +0.0657824856 +0.0656193482 +0.0654565414 +0.0652940645 +0.0651319173 +0.0649700991 +0.0648086095 +0.0646474482 +0.0644866146 +0.0643261083 +0.0641659289 +0.0640060759 +0.0638465488 +0.0636873472 +0.0635284706 +0.0633699186 +0.0632116907 +0.0630537866 +0.0628962057 +0.0627389475 +0.0625820117 +0.0624253978 +0.0622691053 +0.0621131337 +0.0619574827 +0.0618021518 +0.0616471405 +0.0614924483 +0.0613380749 +0.0611840198 +0.0610302825 +0.0608768625 +0.0607237595 +0.0605709729 +0.0604185023 +0.0602663473 +0.0601145075 +0.0599629823 +0.0598117713 +0.059660874 +0.0595102901 +0.059360019 +0.0592100604 +0.0590604137 +0.0589110785 +0.0587620544 +0.0586133409 +0.0584649376 +0.058316844 +0.0581690596 +0.0580215841 +0.0578744169 +0.0577275577 +0.0575810059 +0.0574347611 +0.0572888229 +0.0571431908 +0.0569978644 +0.0568528432 +0.0567081268 +0.0565637147 +0.0564196064 +0.0562758016 +0.0561322998 +0.0559891006 +0.0558462034 +0.0557036078 +0.0555613134 +0.0554193198 +0.0552776265 +0.055136233 +0.0549951389 +0.0548543437 +0.0547138471 +0.0545736485 +0.0544337476 +0.0542941438 +0.0541548367 +0.0540158259 +0.0538771109 +0.0537386913 +0.0536005666 +0.0534627364 +0.0533252003 +0.0531879578 +0.0530510084 +0.0529143517 +0.0527779873 +0.0526419147 +0.0525061335 +0.0523706432 +0.0522354434 +0.0521005336 +0.0519659134 +0.0518315824 +0.0516975401 +0.051563786 +0.0514303198 +0.0512971409 +0.051164249 +0.0510316436 +0.0508993242 +0.0507672905 +0.0506355419 +0.050504078 +0.0503728984 +0.0502420027 +0.0501113903 +0.0499810609 +0.049851014 +0.0497212492 +0.0495917661 +0.0494625641 +0.0493336429 +0.049205002 +0.0490766409 +0.0489485593 +0.0488207567 +0.0486932327 +0.0485659867 +0.0484390184 +0.0483123274 +0.0481859132 +0.0480597753 +0.0479339134 +0.0478083269 +0.0476830155 +0.0475579787 +0.047433216 +0.0473087271 +0.0471845115 +0.0470605688 +0.0469368985 +0.0468135001 +0.0466903734 +0.0465675177 +0.0464449327 +0.046322618 +0.046200573 +0.0460787975 +0.0459572909 +0.0458360528 +0.0457150827 +0.0455943803 +0.0454739452 +0.0453537767 +0.0452338747 +0.0451142385 +0.0449948678 +0.0448757621 +0.0447569211 +0.0446383442 +0.0445200311 +0.0444019812 +0.0442841943 +0.0441666698 +0.0440494073 +0.0439324064 +0.0438156667 +0.0436991877 +0.043582969 +0.0434670102 +0.0433513108 +0.0432358705 +0.0431206887 +0.043005765 +0.0428910991 +0.0427766905 +0.0426625388 +0.0425486435 +0.0424350042 +0.0423216205 +0.042208492 +0.0420956182 +0.0419829987 +0.0418706331 +0.041758521 +0.0416466619 +0.0415350554 +0.0414237011 +0.0413125986 +0.0412017474 +0.0410911471 +0.0409807973 +0.0408706976 +0.0407608475 +0.0406512466 +0.0405418946 +0.0404327909 +0.0403239351 +0.0402153269 +0.0401069659 +0.0399988515 +0.0398909834 +0.0397833611 +0.0396759843 +0.0395688524 +0.0394619652 +0.0393553221 +0.0392489228 +0.0391427669 +0.0390368538 +0.0389311833 +0.0388257548 +0.038720568 +0.0386156225 +0.0385109178 +0.0384064535 +0.0383022292 +0.0381982445 +0.0380944989 +0.0379909922 +0.0378877237 +0.0377846932 +0.0376819002 +0.0375793443 +0.0374770251 +0.0373749421 +0.037273095 +0.0371714834 +0.0370701068 +0.0369689648 +0.036868057 +0.036767383 +0.0366669424 +0.0365667348 +0.0364667598 +0.0363670169 +0.0362675058 +0.036168226 +0.0360691772 +0.0359703588 +0.0358717706 +0.0357734121 +0.0356752829 +0.0355773826 +0.0354797108 +0.035382267 +0.0352850509 +0.0351880621 +0.0350913002 +0.0349947647 +0.0348984553 +0.0348023715 +0.034706513 +0.0346108793 +0.03451547 +0.0344202848 +0.0343253232 +0.0342305849 +0.0341360693 +0.0340417762 +0.0339477051 +0.0338538557 +0.0337602275 +0.0336668201 +0.0335736331 +0.0334806661 +0.0333879188 +0.0332953907 +0.0332030814 +0.0331109906 +0.0330191178 +0.0329274626 +0.0328360247 +0.0327448036 +0.032653799 +0.0325630104 +0.0324724374 +0.0323820798 +0.032291937 +0.0322020086 +0.0321122944 +0.0320227938 +0.0319335065 +0.0318444322 +0.0317555703 +0.0316669205 +0.0315784825 +0.0314902558 +0.03140224 +0.0313144348 +0.0312268397 +0.0311394545 +0.0310522785 +0.0309653116 +0.0308785533 +0.0307920032 +0.0307056609 +0.0306195261 +0.0305335983 +0.0304478772 +0.0303623624 +0.0302770534 +0.03019195 +0.0301070517 +0.0300223581 +0.0299378689 +0.0298535836 +0.0297695019 +0.0296856235 +0.0296019478 +0.0295184746 +0.0294352034 +0.0293521339 +0.0292692657 +0.0291865984 +0.0291041317 +0.0290218651 +0.0289397982 +0.0288579308 +0.0287762624 +0.0286947925 +0.028613521 +0.0285324473 +0.0284515712 +0.0283708921 +0.0282904098 +0.0282101239 +0.0281300339 +0.0280501396 +0.0279704406 +0.0278909364 +0.0278116267 +0.0277325111 +0.0276535892 +0.0275748608 +0.0274963253 +0.0274179825 +0.0273398319 +0.0272618733 +0.0271841061 +0.0271065301 +0.0270291449 +0.02695195 +0.0268749452 +0.0267981301 +0.0267215043 +0.0266450674 +0.0265688191 +0.026492759 +0.0264168867 +0.0263412018 +0.0262657041 +0.0261903931 +0.0261152685 +0.0260403299 +0.0259655769 +0.0258910092 +0.0258166264 +0.0257424281 +0.0256684141 +0.0255945838 +0.025520937 +0.0254474734 +0.0253741924 +0.0253010939 +0.0252281773 +0.0251554425 +0.0250828889 +0.0250105163 +0.0249383242 +0.0248663124 +0.0247944804 +0.024722828 +0.0246513547 +0.0245800602 +0.0245089441 +0.0244380061 +0.0243672459 +0.024296663 +0.0242262572 +0.024156028 +0.0240859752 +0.0240160983 +0.023946397 +0.023876871 +0.0238075198 +0.0237383433 +0.0236693409 +0.0236005124 +0.0235318574 +0.0234633755 +0.0233950665 +0.0233269299 +0.0232589654 +0.0231911727 +0.0231235514 +0.0230561011 +0.0229888216 +0.0229217125 +0.0228547733 +0.0227880039 +0.0227214038 +0.0226549727 +0.0225887102 +0.0225226161 +0.0224566899 +0.0223909313 +0.0223253401 +0.0222599157 +0.0221946579 +0.0221295665 +0.0220646409 +0.0219998809 +0.0219352861 +0.0218708562 +0.0218065909 +0.0217424898 +0.0216785526 +0.0216147789 +0.0215511684 +0.0214877208 +0.0214244358 +0.0213613129 +0.0212983519 +0.0212355524 +0.0211729142 +0.0211104367 +0.0210481198 +0.0209859632 +0.0209239663 +0.020862129 +0.0208004509 +0.0207389317 +0.020677571 +0.0206163685 +0.0205553239 +0.0204944368 +0.020433707 +0.020373134 +0.0203127176 +0.0202524574 +0.0201923532 +0.0201324045 +0.0200726111 +0.0200129726 +0.0199534887 +0.019894159 +0.0198349834 +0.0197759613 +0.0197170926 +0.0196583768 +0.0195998137 +0.019541403 +0.0194831442 +0.0194250372 +0.0193670815 +0.0193092769 +0.019251623 +0.0191941195 +0.0191367661 +0.0190795625 +0.0190225083 +0.0189656032 +0.018908847 +0.0188522393 +0.0187957798 +0.0187394681 +0.018683304 +0.0186272872 +0.0185714172 +0.0185156939 +0.0184601169 +0.0184046858 +0.0183494004 +0.0182942604 +0.0182392654 +0.0181844152 +0.0181297094 +0.0180751476 +0.0180207297 +0.0179664553 +0.0179123241 +0.0178583357 +0.0178044899 +0.0177507863 +0.0176972247 +0.0176438048 +0.0175905261 +0.0175373885 +0.0174843916 +0.0174315352 +0.0173788188 +0.0173262423 +0.0172738052 +0.0172215074 +0.0171693484 +0.0171173281 +0.017065446 +0.0170137019 +0.0169620956 +0.0169106266 +0.0168592946 +0.0168080995 +0.0167570409 +0.0167061184 +0.0166553319 +0.0166046809 +0.0165541652 +0.0165037845 +0.0164535385 +0.0164034269 +0.0163534494 +0.0163036058 +0.0162538956 +0.0162043187 +0.0161548747 +0.0161055633 +0.0160563842 +0.0160073373 +0.015958422 +0.0159096382 +0.0158609856 +0.0158124639 +0.0157640728 +0.0157158119 +0.0156676811 +0.01561968 +0.0155718083 +0.0155240657 +0.015476452 +0.0154289669 +0.0153816101 +0.0153343812 +0.01528728 +0.0152403063 +0.0151934597 +0.01514674 +0.0151001468 +0.0150536799 +0.015007339 +0.0149611238 +0.0149150341 +0.0148690695 +0.0148232297 +0.0147775146 +0.0147319237 +0.0146864569 +0.0146411139 +0.0145958943 +0.0145507978 +0.0145058243 +0.0144609735 +0.0144162449 +0.0143716385 +0.0143271538 +0.0142827907 +0.0142385488 +0.0141944279 +0.0141504277 +0.0141065479 +0.0140627883 +0.0140191485 +0.0139756283 +0.0139322275 +0.0138889457 +0.0138457826 +0.0138027381 +0.0137598119 +0.0137170036 +0.013674313 +0.0136317398 +0.0135892838 +0.0135469447 +0.0135047222 +0.013462616 +0.013420626 +0.0133787518 +0.0133369931 +0.0132953497 +0.0132538213 +0.0132124077 +0.0131711085 +0.0131299236 +0.0130888527 +0.0130478954 +0.0130070516 +0.012966321 +0.0129257033 +0.0128851982 +0.0128448055 +0.0128045249 +0.0127643562 +0.0127242991 +0.0126843534 +0.0126445187 +0.0126047949 +0.0125651816 +0.0125256786 +0.0124862857 +0.0124470026 +0.012407829 +0.0123687648 +0.0123298095 +0.012290963 +0.012252225 +0.0122135953 +0.0121750736 +0.0121366597 +0.0120983533 +0.0120601541 +0.0120220619 +0.0119840764 +0.0119461975 +0.0119084248 +0.0118707581 +0.0118331971 +0.0117957416 +0.0117583914 +0.0117211461 +0.0116840056 +0.0116469697 +0.0116100379 +0.0115732102 +0.0115364862 +0.0114998657 +0.0114633485 +0.0114269343 +0.0113906229 +0.011354414 +0.0113183075 +0.0112823029 +0.0112464002 +0.011210599 +0.0111748991 +0.0111393003 +0.0111038023 +0.0110684049 +0.0110331079 +0.010997911 +0.0109628139 +0.0109278165 +0.0108929185 +0.0108581196 +0.0108234196 +0.0107888184 +0.0107543155 +0.0107199109 +0.0106856042 +0.0106513952 +0.0106172838 +0.0105832696 +0.0105493524 +0.0105155321 +0.0104818083 +0.0104481808 +0.0104146494 +0.0103812138 +0.0103478739 +0.0103146294 +0.01028148 +0.0102484256 +0.0102154659 +0.0101826006 +0.0101498296 +0.0101171526 +0.0100845694 +0.0100520797 +0.0100196834 +0.00998738017 +0.00995516981 +0.0099230521 +0.00989102681 +0.00985909371 +0.00982725258 +0.0097955032 +0.00976384533 +0.00973227876 +0.00970080326 +0.00966941861 +0.00963812459 +0.00960692096 +0.00957580752 +0.00954478403 +0.00951385028 +0.00948300605 +0.00945225111 +0.00942158525 +0.00939100825 +0.00936051988 +0.00933011993 +0.00929980818 +0.00926958441 +0.0092394484 +0.00920939995 +0.00917943882 +0.0091495648 +0.00911977768 +0.00909007725 +0.00906046328 +0.00903093556 +0.00900149388 +0.00897213803 +0.00894286778 +0.00891368293 +0.00888458327 +0.00885556858 +0.00882663865 +0.00879779327 +0.00876903222 +0.00874035531 +0.00871176231 +0.00868325301 +0.00865482722 +0.00862648471 +0.00859822528 +0.00857004872 +0.00854195483 +0.00851394339 +0.0084860142 +0.00845816706 +0.00843040175 +0.00840271807 +0.00837511581 +0.00834759477 +0.00832015475 +0.00829279554 +0.00826551694 +0.00823831874 +0.00821120074 +0.00818416274 +0.00815720453 +0.00813032592 +0.00810352669 +0.00807680666 +0.00805016562 +0.00802360337 +0.00799711971 +0.00797071444 +0.00794438736 +0.00791813827 +0.00789196697 +0.00786587328 +0.00783985698 +0.00781391788 +0.00778805579 +0.0077622705 +0.00773656183 +0.00771092957 +0.00768537354 +0.00765989353 +0.00763448935 +0.00760916081 +0.00758390772 +0.00755872987 +0.00753362709 +0.00750859916 +0.00748364592 +0.00745876715 +0.00743396268 +0.0074092323 +0.00738457583 +0.00735999309 +0.00733548387 +0.00731104799 +0.00728668525 +0.00726239549 +0.00723817849 +0.00721403408 +0.00718996207 +0.00716596226 +0.00714203449 +0.00711817854 +0.00709439425 +0.00707068143 +0.00704703989 +0.00702346944 +0.0069999699 +0.00697654109 +0.00695318282 +0.00692989492 +0.00690667719 +0.00688352945 +0.00686045153 +0.00683744323 +0.00681450439 +0.00679163481 +0.00676883431 +0.00674610273 +0.00672343987 +0.00670084556 +0.00667831961 +0.00665586185 +0.00663347211 +0.00661115019 +0.00658889593 +0.00656670914 +0.00654458966 +0.00652253729 +0.00650055188 +0.00647863323 +0.00645678118 +0.00643499555 +0.00641327616 +0.00639162284 +0.00637003542 +0.00634851373 +0.00632705758 +0.0063056668 +0.00628434123 +0.00626308069 +0.00624188501 +0.00622075402 +0.00619968755 +0.00617868542 +0.00615774746 +0.00613687351 +0.00611606339 +0.00609531694 +0.00607463399 +0.00605401436 +0.0060334579 +0.00601296442 +0.00599253377 +0.00597216578 +0.00595186027 +0.00593161709 +0.00591143607 +0.00589131703 +0.00587125982 +0.00585126428 +0.00583133022 +0.0058114575 +0.00579164595 +0.0057718954 +0.00575220569 +0.00573257665 +0.00571300813 +0.00569349997 +0.00567405199 +0.00565466404 +0.00563533596 +0.00561606758 +0.00559685875 +0.0055777093 +0.00555861908 +0.00553958793 +0.00552061568 +0.00550170218 +0.00548284727 +0.00546405079 +0.00544531259 +0.00542663249 +0.00540801036 +0.00538944603 +0.00537093935 +0.00535249015 +0.00533409829 +0.00531576361 +0.00529748594 +0.00527926515 +0.00526110107 +0.00524299355 +0.00522494244 +0.00520694758 +0.00518900882 +0.005171126 +0.00515329899 +0.00513552761 +0.00511781172 +0.00510015117 +0.00508254582 +0.00506499549 +0.00504750006 +0.00503005936 +0.00501267325 +0.00499534158 +0.0049780642 +0.00496084096 +0.00494367171 +0.0049265563 +0.00490949459 +0.00489248643 +0.00487553167 +0.00485863017 +0.00484178177 +0.00482498634 +0.00480824372 +0.00479155378 +0.00477491636 +0.00475833132 +0.00474179852 +0.00472531781 +0.00470888905 +0.0046925121 +0.00467618681 +0.00465991304 +0.00464369064 +0.00462751948 +0.00461139942 +0.0045953303 +0.004579312 +0.00456334437 +0.00454742726 +0.00453156054 +0.00451574407 +0.00449997771 +0.00448426132 +0.00446859476 +0.0044529779 +0.00443741058 +0.00442189269 +0.00440642406 +0.00439100459 +0.00437563411 +0.0043603125 +0.00434503962 +0.00432981533 +0.0043146395 +0.004299512 +0.00428443268 +0.00426940142 +0.00425441807 +0.0042394825 +0.00422459459 +0.00420975419 +0.00419496117 +0.00418021541 +0.00416551675 +0.00415086509 +0.00413626027 +0.00412170218 +0.00410719067 +0.00409272563 +0.0040783069 +0.00406393438 +0.00404960792 +0.00403532739 +0.00402109268 +0.00400690363 +0.00399276014 +0.00397866206 +0.00396460928 +0.00395060165 +0.00393663906 +0.00392272138 +0.00390884848 +0.00389502022 +0.0038812365 +0.00386749717 +0.00385380211 +0.0038401512 +0.00382654432 +0.00381298133 +0.00379946211 +0.00378598654 +0.00377255449 +0.00375916583 +0.00374582046 +0.00373251823 +0.00371925903 +0.00370604274 +0.00369286923 +0.00367973838 +0.00366665007 +0.00365360417 +0.00364060057 +0.00362763915 +0.00361471977 +0.00360184233 +0.0035890067 +0.00357621277 +0.0035634604 +0.00355074949 +0.00353807992 +0.00352545155 +0.00351286429 +0.003500318 +0.00348781258 +0.00347534789 +0.00346292383 +0.00345054028 +0.00343819712 +0.00342589424 +0.00341363151 +0.00340140883 +0.00338922607 +0.00337708312 +0.00336497987 +0.0033529162 +0.003340892 +0.00332890715 +0.00331696153 +0.00330505504 +0.00329318756 +0.00328135898 +0.00326956918 +0.00325781806 +0.00324610549 +0.00323443137 +0.00322279558 +0.00321119802 +0.00319963857 +0.00318811713 +0.00317663357 +0.00316518779 +0.00315377968 +0.00314240913 +0.00313107603 +0.00311978028 +0.00310852175 +0.00309730035 +0.00308611595 +0.00307496847 +0.00306385778 +0.00305278378 +0.00304174636 +0.00303074542 +0.00301978085 +0.00300885253 +0.00299796037 +0.00298710426 +0.00297628409 +0.00296549975 +0.00295475115 +0.00294403817 +0.00293336071 +0.00292271867 +0.00291211194 +0.00290154042 +0.002891004 +0.00288050258 +0.00287003605 +0.00285960432 +0.00284920728 +0.00283884483 +0.00282851686 +0.00281822327 +0.00280796397 +0.00279773885 +0.0027875478 +0.00277739073 +0.00276726754 +0.00275717812 +0.00274712238 +0.00273710022 +0.00272711153 +0.00271715621 +0.00270723417 +0.00269734531 +0.00268748953 +0.00267766673 +0.00266787681 +0.00265811967 +0.00264839522 +0.00263870336 +0.00262904399 +0.00261941701 +0.00260982233 +0.00260025985 +0.00259072947 +0.00258123111 +0.00257176465 +0.00256233001 +0.00255292709 +0.00254355579 +0.00253421603 +0.0025249077 +0.00251563072 +0.00250638498 +0.0024971704 +0.00248798687 +0.00247883431 +0.00246971263 +0.00246062173 +0.00245156151 +0.00244253189 +0.00243353277 +0.00242456406 +0.00241562567 +0.0024067175 +0.00239783948 +0.00238899149 +0.00238017347 +0.0023713853 +0.00236262691 +0.0023538982 +0.00234519908 +0.00233652947 +0.00232788927 +0.00231927839 +0.00231069675 +0.00230214426 +0.00229362082 +0.00228512636 +0.00227666077 +0.00226822398 +0.0022598159 +0.00225143643 +0.0022430855 +0.00223476301 +0.00222646888 +0.00221820302 +0.00220996535 +0.00220175577 +0.00219357421 +0.00218542057 +0.00217729478 +0.00216919674 +0.00216112638 +0.0021530836 +0.00214506833 +0.00213708048 +0.00212911996 +0.00212118669 +0.00211328059 +0.00210540157 +0.00209754955 +0.00208972445 +0.00208192619 +0.00207415468 +0.00206640983 +0.00205869158 +0.00205099983 +0.00204333451 +0.00203569553 +0.00202808281 +0.00202049628 +0.00201293584 +0.00200540142 +0.00199789294 +0.00199041033 +0.00198295349 +0.00197552234 +0.00196811682 +0.00196073684 +0.00195338233 +0.00194605319 +0.00193874936 +0.00193147075 +0.00192421729 +0.0019169889 +0.0019097855 +0.00190260702 +0.00189545337 +0.00188832448 +0.00188122027 +0.00187414067 +0.0018670856 +0.00186005497 +0.00185304873 +0.00184606678 +0.00183910906 +0.00183217549 +0.00182526599 +0.00181838049 +0.00181151891 +0.00180468119 +0.00179786723 +0.00179107698 +0.00178431035 +0.00177756727 +0.00177084767 +0.00176415147 +0.0017574786 +0.001750829 +0.00174420257 +0.00173759926 +0.00173101899 +0.00172446168 +0.00171792727 +0.00171141568 +0.00170492685 +0.00169846069 +0.00169201714 +0.00168559613 +0.00167919758 +0.00167282143 +0.0016664676 +0.00166013602 +0.00165382663 +0.00164753936 +0.00164127412 +0.00163503086 +0.00162880951 +0.00162260999 +0.00161643224 +0.00161027618 +0.00160414175 +0.00159802889 +0.00159193751 +0.00158586756 +0.00157981896 +0.00157379165 +0.00156778556 +0.00156180063 +0.00155583678 +0.00154989395 +0.00154397207 +0.00153807107 +0.00153219089 +0.00152633147 +0.00152049273 +0.00151467461 +0.00150887705 +0.00150309998 +0.00149734332 +0.00149160703 +0.00148589103 +0.00148019526 +0.00147451965 +0.00146886414 +0.00146322867 +0.00145761317 +0.00145201757 +0.00144644182 +0.00144088585 +0.00143534959 +0.00142983298 +0.00142433597 +0.00141885848 +0.00141340046 +0.00140796183 +0.00140254255 +0.00139714255 +0.00139176175 +0.00138640012 +0.00138105757 +0.00137573405 +0.00137042951 +0.00136514387 +0.00135987707 +0.00135462907 +0.00134939978 +0.00134418917 +0.00133899715 +0.00133382368 +0.0013286687 +0.00132353214 +0.00131841394 +0.00131331405 +0.00130823241 +0.00130316895 +0.00129812362 +0.00129309636 +0.00128808711 +0.00128309582 +0.00127812241 +0.00127316685 +0.00126822906 +0.00126330899 +0.00125840658 +0.00125352178 +0.00124865453 +0.00124380477 +0.00123897244 +0.00123415748 +0.00122935985 +0.00122457948 +0.00121981632 +0.00121507031 +0.00121034139 +0.00120562952 +0.00120093463 +0.00119625666 +0.00119159557 +0.0011869513 +0.00118232379 +0.00117771298 +0.00117311883 +0.00116854128 +0.00116398027 +0.00115943575 +0.00115490767 +0.00115039596 +0.00114590059 +0.00114142149 +0.00113695861 +0.0011325119 +0.0011280813 +0.00112366676 +0.00111926823 +0.00111488566 +0.00111051899 +0.00110616817 +0.00110183315 +0.00109751387 +0.00109321029 +0.00108892235 +0.00108465 +0.00108039319 +0.00107615187 +0.00107192598 +0.00106771548 +0.00106352032 +0.00105934043 +0.00105517579 +0.00105102632 +0.00104689199 +0.00104277274 +0.00103866852 +0.00103457928 +0.00103050498 +0.00102644555 +0.00102240097 +0.00101837116 +0.00101435609 +0.00101035571 +0.00100636997 +0.00100239881 +0.000998442191 +0.000994500065 +0.000990572382 +0.000986659094 +0.000982760152 +0.00097887551 +0.000975005119 +0.000971148931 +0.0009673069 +0.000963478977 +0.000959665116 +0.00095586527 +0.000952079391 +0.000948307433 +0.00094454935 +0.000940805094 +0.00093707462 +0.000933357881 +0.000929654832 +0.000925965425 +0.000922289616 +0.000918627359 +0.000914978608 +0.000911343318 +0.000907721443 +0.000904112939 +0.00090051776 +0.000896935862 +0.000893367199 +0.000889811728 +0.000886269404 +0.000882740182 +0.000879224018 +0.000875720869 +0.000872230689 +0.000868753436 +0.000865289066 +0.000861837535 +0.0008583988 +0.000854972818 +0.000851559545 +0.000848158938 +0.000844770954 +0.000841395552 +0.000838032687 +0.000834682318 +0.000831344402 +0.000828018897 +0.00082470576 +0.000821404951 +0.000818116426 +0.000814840144 +0.000811576064 +0.000808324144 +0.000805084342 +0.000801856618 +0.00079864093 +0.000795437238 +0.000792245499 +0.000789065675 +0.000785897723 +0.000782741604 +0.000779597277 +0.000776464701 +0.000773343838 +0.000770234646 +0.000767137086 +0.000764051117 +0.000760976702 +0.000757913798 +0.000754862369 +0.000751822373 +0.000748793772 +0.000745776528 +0.0007427706 +0.00073977595 +0.000736792539 +0.000733820329 +0.000730859282 +0.000727909359 +0.000724970521 +0.000722042731 +0.000719125951 +0.000716220142 +0.000713325267 +0.000710441289 +0.000707568169 +0.000704705871 +0.000701854357 +0.00069901359 +0.000696183533 +0.000693364148 +0.000690555399 +0.00068775725 +0.000684969663 +0.000682192603 +0.000679426032 +0.000676669914 +0.000673924214 +0.000671188895 +0.000668463921 +0.000665749256 +0.000663044866 +0.000660350713 +0.000657666762 +0.000654992979 +0.000652329328 +0.000649675773 +0.00064703228 +0.000644398813 +0.000641775339 +0.000639161821 +0.000636558225 +0.000633964518 +0.000631380663 +0.000628806628 +0.000626242378 +0.000623687878 +0.000621143095 +0.000618607995 +0.000616082544 +0.000613566709 +0.000611060455 +0.00060856375 +0.000606076559 +0.00060359885 +0.00060113059 +0.000598671745 +0.000596222283 +0.00059378217 +0.000591351374 +0.000588929863 +0.000586517603 +0.000584114562 +0.000581720709 +0.00057933601 +0.000576960433 +0.000574593947 +0.00057223652 +0.000569888119 +0.000567548713 +0.000565218271 +0.000562896761 +0.000560584151 +0.000558280409 +0.000555985506 +0.00055369941 +0.000551422088 +0.000549153512 +0.00054689365 +0.00054464247 +0.000542399943 +0.000540166038 +0.000537940724 +0.000535723971 +0.000533515749 +0.000531316027 +0.000529124776 +0.000526941966 +0.000524767566 +0.000522601547 +0.000520443879 +0.000518294532 +0.000516153478 +0.000514020686 +0.000511896128 +0.000509779773 +0.000507671594 +0.00050557156 +0.000503479643 +0.000501395815 +0.000499320045 +0.000497252307 +0.00049519257 +0.000493140807 +0.000491096989 +0.000489061088 +0.000487033076 +0.000485012924 +0.000483000604 +0.000480996089 +0.000478999351 +0.000477010361 +0.000475029093 +0.000473055518 +0.00047108961 +0.00046913134 +0.000467180681 +0.000465237607 +0.000463302089 +0.000461374102 +0.000459453617 +0.000457540609 +0.000455635049 +0.000453736912 +0.000451846171 +0.0004499628 +0.000448086771 +0.000446218058 +0.000444356636 +0.000442502478 +0.000440655558 +0.000438815849 +0.000436983327 +0.000435157964 +0.000433339736 +0.000431528616 +0.00042972458 +0.0004279276 +0.000426137653 +0.000424354712 +0.000422578752 +0.000420809748 +0.000419047676 +0.000417292509 +0.000415544223 +0.000413802794 +0.000412068195 +0.000410340403 +0.000408619393 +0.000406905141 +0.000405197621 +0.00040349681 +0.000401802683 +0.000400115216 +0.000398434385 +0.000396760165 +0.000395092534 +0.000393431466 +0.000391776938 +0.000390128926 +0.000388487407 +0.000386852356 +0.000385223751 +0.000383601568 +0.000381985783 +0.000380376374 +0.000378773316 +0.000377176588 +0.000375586165 +0.000374002025 +0.000372424145 +0.000370852502 +0.000369287073 +0.000367727836 +0.000366174768 +0.000364627846 +0.000363087048 +0.000361552352 +0.000360023735 +0.000358501175 +0.000356984649 +0.000355474136 +0.000353969614 +0.000352471061 +0.000350978455 +0.000349491773 +0.000348010995 +0.000346536098 +0.000345067062 +0.000343603864 +0.000342146483 +0.000340694897 +0.000339249086 +0.000337809028 +0.000336374702 +0.000334946087 +0.000333523162 +0.000332105906 +0.000330694297 +0.000329288316 +0.000327887941 +0.000326493152 +0.000325103928 +0.000323720249 +0.000322342094 +0.000320969442 +0.000319602274 +0.000318240569 +0.000316884307 +0.000315533468 +0.000314188031 +0.000312847978 +0.000311513287 +0.000310183939 +0.000308859914 +0.000307541192 +0.000306227754 +0.000304919581 +0.000303616652 +0.000302318948 +0.00030102645 +0.000299739138 +0.000298456993 +0.000297179997 +0.000295908129 +0.00029464137 +0.000293379703 +0.000292123107 +0.000290871565 +0.000289625056 +0.000288383562 +0.000287147065 +0.000285915547 +0.000284688987 +0.000283467369 +0.000282250672 +0.00028103888 +0.000279831974 +0.000278629935 +0.000277432746 +0.000276240388 +0.000275052843 +0.000273870093 +0.00027269212 +0.000271518906 +0.000270350434 +0.000269186686 +0.000268027644 +0.000266873289 +0.000265723606 +0.000264578576 +0.000263438182 +0.000262302406 +0.000261171231 +0.00026004464 +0.000258922615 +0.00025780514 +0.000256692197 +0.000255583769 +0.000254479839 +0.000253380391 +0.000252285407 +0.00025119487 +0.000250108764 +0.000249027073 +0.000247949779 +0.000246876865 +0.000245808316 +0.000244744115 +0.000243684245 +0.000242628691 +0.000241577435 +0.000240530462 +0.000239487755 +0.000238449298 +0.000237415075 +0.00023638507 +0.000235359268 +0.000234337651 +0.000233320205 +0.000232306914 +0.000231297761 +0.000230292731 +0.000229291809 +0.000228294978 +0.000227302224 +0.000226313531 +0.000225328883 +0.000224348265 +0.000223371661 +0.000222399058 +0.000221430438 +0.000220465787 +0.00021950509 +0.000218548332 +0.000217595498 +0.000216646573 +0.000215701542 +0.00021476039 +0.000213823102 +0.000212889664 +0.000211960061 +0.000211034278 +0.000210112301 +0.000209194114 +0.000208279705 +0.000207369058 +0.000206462158 +0.000205558992 +0.000204659545 +0.000203763803 +0.000202871752 +0.000201983377 +0.000201098665 +0.000200217601 +0.000199340172 +0.000198466363 +0.000197596161 +0.000196729551 +0.000195866521 +0.000195007056 +0.000194151142 +0.000193298766 +0.000192449915 +0.000191604574 +0.00019076273 +0.00018992437 +0.000189089481 +0.000188258048 +0.000187430059 +0.0001866055 +0.000185784359 +0.000184966621 +0.000184152274 +0.000183341305 +0.0001825337 +0.000181729447 +0.000180928533 +0.000180130945 +0.00017933667 +0.000178545694 +0.000177758007 +0.000176973594 +0.000176192442 +0.00017541454 +0.000174639875 +0.000173868435 +0.000173100205 +0.000172335175 +0.000171573332 +0.000170814664 +0.000170059157 +0.000169306801 +0.000168557582 +0.000167811488 +0.000167068508 +0.000166328629 +0.000165591839 +0.000164858127 +0.000164127479 +0.000163399885 +0.000162675332 +0.000161953808 +0.000161235302 +0.000160519802 +0.000159807296 +0.000159097773 +0.00015839122 +0.000157687627 +0.000156986981 +0.000156289272 +0.000155594487 +0.000154902616 +0.000154213646 +0.000153527567 +0.000152844368 +0.000152164036 +0.000151486561 +0.000150811931 +0.000150140136 +0.000149471164 +0.000148805005 +0.000148141646 +0.000147481078 +0.000146823289 +0.000146168268 +0.000145516005 +0.000144866489 +0.000144219708 +0.000143575652 +0.000142934311 +0.000142295674 +0.000141659729 +0.000141026467 +0.000140395877 +0.000139767949 +0.000139142671 +0.000138520034 +0.000137900026 +0.000137282639 +0.000136667861 +0.000136055681 +0.000135446091 +0.000134839079 +0.000134234636 +0.000133632751 +0.000133033414 +0.000132436615 +0.000131842343 +0.00013125059 +0.000130661345 +0.000130074599 +0.00012949034 +0.00012890856 +0.000128329248 +0.000127752395 +0.000127177991 +0.000126606027 +0.000126036492 +0.000125469377 +0.000124904672 +0.000124342368 +0.000123782455 +0.000123224925 +0.000122669766 +0.00012211697 +0.000121566528 +0.00012101843 +0.000120472667 +0.000119929229 +0.000119388107 +0.000118849292 +0.000118312775 +0.000117778547 +0.000117246598 +0.00011671692 + +shape_id 2 +num_samples 8000 +0 +0 +7998 + +shape_id 3 +num_samples 3000 +9.14157145e-11 +2.46985517e-09 +1.14419998e-08 +3.14172076e-08 +6.68159063e-08 +1.22069341e-07 +2.01619321e-07 +3.09917965e-07 +4.51427445e-07 +6.30619731e-07 +8.51976334e-07 +1.11998804e-06 +1.43915468e-06 +1.81398481e-06 +2.24899552e-06 +2.74871213e-06 +3.31766794e-06 +3.96040395e-06 +4.68146863e-06 +5.48541761e-06 +6.37681346e-06 +7.36022539e-06 +8.44022899e-06 +9.62140598e-06 +1.09083439e-05 +1.23056359e-05 +1.38178804e-05 +1.54496809e-05 +1.72056456e-05 +1.90903871e-05 +2.11085226e-05 +2.32646727e-05 +2.5563462e-05 +2.80095185e-05 +3.06074732e-05 +3.33619599e-05 +3.6277615e-05 +3.93590773e-05 +4.26109873e-05 +4.60379876e-05 +4.96447219e-05 +5.34358353e-05 +5.74159736e-05 +6.15897832e-05 +6.59619109e-05 +7.05370036e-05 +7.53197076e-05 +8.0314669e-05 +8.5526533e-05 +9.09599435e-05 +9.66195432e-05 +0.000102509973 +0.000108635872 +0.000115001876 +0.000121612621 +0.000128472737 +0.000135586852 +0.000142959591 +0.000150595575 +0.000158499421 +0.000166675742 +0.000175129145 +0.000183864235 +0.00019288561 +0.000202197861 +0.000211805575 +0.000221713335 +0.000231925713 +0.000242447278 +0.000253282591 +0.000264436206 +0.000275912667 +0.000287716515 +0.000299852279 +0.000312324481 +0.000325137633 +0.000338296241 +0.000351804799 +0.000365667792 +0.000379889695 +0.000394474974 +0.000409428083 +0.000424753467 +0.000440455557 +0.000456538775 +0.000473007532 +0.000489866224 +0.000507119238 +0.000524770946 +0.000542825708 +0.000561287871 +0.000580161769 +0.000599451722 +0.000619162034 +0.000639296997 +0.000659860888 +0.000680857968 +0.000702292483 +0.000724168666 +0.000746490729 +0.000769262873 +0.000792489279 +0.000816174114 +0.000840321525 +0.000864935645 +0.000890020586 +0.000915580444 +0.000941619297 +0.000968141203 +0.000995150203 +0.00102265032 +0.00105064555 +0.00107913988 +0.00110813726 +0.00113764165 +0.00116765696 +0.00119818709 +0.00122923593 +0.00126080731 +0.0012929051 +0.00132553309 +0.00135869507 +0.00139239482 +0.00142663608 +0.00146142258 +0.001496758 +0.00153264603 +0.00156909032 +0.00160609449 +0.00164366214 +0.00168179686 +0.00172050218 +0.00175978164 +0.00179963874 +0.00184007694 +0.0018810997 +0.00192271043 +0.00196491254 +0.00200770937 +0.00205110429 +0.00209510058 +0.00213970154 +0.00218491041 +0.00223073043 +0.00227716478 +0.00232421664 +0.00237188914 +0.00242018539 +0.00246910847 +0.00251866141 +0.00256884724 +0.00261966894 +0.00267112947 +0.00272323174 +0.00277597864 +0.00282937304 +0.00288341775 +0.00293811558 +0.00299346927 +0.00304948156 +0.00310615513 +0.00316349266 +0.00322149675 +0.00328017001 +0.00333951498 +0.00339953419 +0.00346023013 +0.00352160525 +0.00358366195 +0.00364640262 +0.00370982961 +0.00377394521 +0.0038387517 +0.00390425132 +0.00397044624 +0.00403733864 +0.00410493063 +0.0041732243 +0.00424222169 +0.0043119248 +0.0043823356 +0.00445345601 +0.00452528793 +0.00459783321 +0.00467109365 +0.00474507101 +0.00481976704 +0.00489518341 +0.00497132178 +0.00504818374 +0.00512577087 +0.00520408468 +0.00528312666 +0.00536289824 +0.00544340083 +0.00552463578 +0.00560660439 +0.00568930794 +0.00577274766 +0.00585692471 +0.00594184025 +0.00602749537 +0.00611389112 +0.00620102849 +0.00628890846 +0.00637753194 +0.0064668998 +0.00655701287 +0.00664787193 +0.00673947771 +0.0068318309 +0.00692493214 +0.00701878203 +0.00711338112 +0.00720872992 +0.00730482887 +0.00740167838 +0.00749927883 +0.00759763052 +0.00769673371 +0.00779658862 +0.00789719543 +0.00799855425 +0.00810066516 +0.00820352817 +0.00830714327 +0.00841151037 +0.00851662936 +0.00862250005 +0.00872912223 +0.00883649561 +0.00894461988 +0.00905349466 +0.00916311953 +0.009273494 +0.00938461754 +0.00949648959 +0.00960910951 +0.00972247662 +0.00983659019 +0.00995144942 +0.0100670535 +0.0101834015 +0.0103004925 +0.0104183255 +0.0105368995 +0.0106562134 +0.0107762659 +0.0108970559 +0.0110185822 +0.0111408434 +0.0112638382 +0.0113875651 +0.0115120227 +0.0116372094 +0.0117631237 +0.0118897639 +0.0120171282 +0.0121452151 +0.0122740227 +0.012403549 +0.0125337923 +0.0126647504 +0.0127964215 +0.0129288035 +0.0130618941 +0.0131956912 +0.0133301926 +0.013465396 +0.0136012989 +0.013737899 +0.0138751939 +0.0140131809 +0.0141518575 +0.0142912211 +0.0144312689 +0.0145719983 +0.0147134063 +0.0148554902 +0.0149982469 +0.0151416736 +0.0152857671 +0.0154305243 +0.0155759422 +0.0157220175 +0.0158687469 +0.0160161271 +0.0161641547 +0.0163128262 +0.0164621382 +0.016612087 +0.0167626691 +0.0169138808 +0.0170657182 +0.0172181778 +0.0173712555 +0.0175249474 +0.0176792496 +0.0178341581 +0.0179896688 +0.0181457774 +0.0183024798 +0.0184597717 +0.0186176488 +0.0187761068 +0.018935141 +0.0190947471 +0.0192549205 +0.0194156565 +0.0195769504 +0.0197387976 +0.0199011931 +0.0200641322 +0.0202276099 +0.0203916212 +0.0205561611 +0.0207212245 +0.0208868062 +0.0210529009 +0.0212195035 +0.0213866084 +0.0215542105 +0.0217223041 +0.0218908838 +0.0220599439 +0.0222294789 +0.022399483 +0.0225699504 +0.0227408754 +0.022912252 +0.0230840744 +0.0232563364 +0.023429032 +0.0236021552 +0.0237756997 +0.0239496593 +0.0241240276 +0.0242987984 +0.0244739651 +0.0246495214 +0.0248254606 +0.0250017762 +0.0251784614 +0.0253555097 +0.0255329141 +0.0257106678 +0.025888764 +0.0260671957 +0.0262459559 +0.0264250374 +0.0266044332 +0.026784136 +0.0269641386 +0.0271444336 +0.0273250137 +0.0275058715 +0.0276869995 +0.02786839 +0.0280500355 +0.0282319284 +0.0284140608 +0.028596425 +0.0287790131 +0.0289618173 +0.0291448296 +0.0293280419 +0.0295114461 +0.0296950342 +0.0298787979 +0.030062729 +0.0302468191 +0.0304310599 +0.0306154429 +0.0307999597 +0.0309846017 +0.0311693603 +0.0313542268 +0.0315391926 +0.0317242489 +0.0319093867 +0.0320945973 +0.0322798717 +0.0324652008 +0.0326505757 +0.0328359871 +0.033021426 +0.0332068831 +0.0333923492 +0.0335778148 +0.0337632706 +0.0339487071 +0.0341341149 +0.0343194843 +0.0345048057 +0.0346900696 +0.034875266 +0.0350603854 +0.0352454177 +0.0354303533 +0.035615182 +0.0357998938 +0.0359844789 +0.0361689269 +0.0363532278 +0.0365373714 +0.0367213474 +0.0369051454 +0.0370887552 +0.0372721662 +0.037455368 +0.0376383501 +0.0378211018 +0.0380036126 +0.0381858718 +0.0383678685 +0.0385495921 +0.0387310317 +0.0389121764 +0.0390930153 +0.0392735373 +0.0394537315 +0.0396335866 +0.0398130917 +0.0399922355 +0.0401710067 +0.0403493941 +0.0405273863 +0.040704972 +0.0408821396 +0.0410588778 +0.0412351749 +0.0414110195 +0.0415863998 +0.0417613042 +0.041935721 +0.0421096384 +0.0422830446 +0.0424559277 +0.0426282758 +0.042800077 +0.0429713192 +0.0431419904 +0.0433120786 +0.0434815715 +0.0436504571 +0.043818723 +0.043986357 +0.0441533468 +0.0443196801 +0.0444853444 +0.0446503273 +0.0448146163 +0.0449781989 +0.0451410625 +0.0453031945 +0.0454645823 +0.0456252131 +0.0457850743 +0.045944153 +0.0461024364 +0.0462599117 +0.0464165659 +0.0465723862 +0.0467273596 +0.046881473 +0.0470347135 +0.0471870678 +0.0473385229 +0.0474890656 +0.0476386828 +0.0477873611 +0.0479350873 +0.0480818481 +0.0482276301 +0.0483724199 +0.0485162042 +0.0486589695 +0.0488007022 +0.0489413889 +0.049081016 +0.0492195698 +0.0493570369 +0.0494934035 +0.0496286559 +0.0497627804 +0.0498957632 +0.0500275906 +0.0501582488 +0.0502877238 +0.0504160018 +0.050543069 +0.0506689113 +0.0507935148 +0.0509168654 +0.0510389492 +0.0511597522 +0.0512792601 +0.051397459 +0.0515143346 +0.0516298728 +0.0517440594 +0.0518568802 +0.0519683209 +0.0520783673 +0.052187005 +0.0522942199 +0.0523999974 +0.0525043232 +0.052607183 +0.0527085623 +0.0528084467 +0.0529068218 +0.0530036729 +0.0530989857 +0.0531927456 +0.0532849381 +0.0533755486 +0.0534645625 +0.0535519652 +0.0536377421 +0.0537218785 +0.0538043597 +0.0538851712 +0.0539642981 +0.0540417258 +0.0541174396 +0.0541914246 +0.0542636662 +0.0543341495 +0.0544028598 +0.0544697821 +0.0545349019 +0.054598204 +0.0546596738 +0.0547192964 +0.0547770568 +0.0548329402 +0.0548869318 +0.0549390164 +0.0549891794 +0.0550374056 +0.0550836803 +0.0551279883 +0.0551703148 +0.0552106448 +0.0552489633 +0.0552852554 +0.0553195059 +0.0553517 +0.0553818226 +0.0554098587 +0.0554357933 +0.0554596113 +0.0554812978 +0.0555008376 +0.0555182158 +0.0555334174 +0.0555464272 +0.0555572302 +0.0555658114 +0.0555721558 +0.0555762482 +0.0555780737 +0.0555776171 +0.0555748635 +0.0555697977 +0.0555624048 +0.0555526697 +0.0555405773 +0.0555261126 +0.0555092605 +0.0554900061 +0.0554683342 +0.05544423 +0.0554176782 +0.055388664 +0.0553571723 +0.0553231882 +0.0552866965 +0.0552476823 +0.0552061307 +0.0551620267 +0.0551153553 +0.0550661015 +0.0550142504 +0.0549597871 +0.0549026966 +0.0548429641 +0.0547805746 +0.0547155132 +0.0546477651 +0.0545773154 +0.0545041492 +0.0544282517 +0.0543496081 +0.0542682036 +0.0541840233 +0.0540970526 +0.0540072766 +0.0539146807 +0.05381925 +0.0537209699 +0.0536198256 +0.0535158026 +0.0534088862 +0.0532990617 +0.0531863145 +0.05307063 +0.0529519938 +0.0528303911 +0.0527058076 +0.0525782286 +0.0524476398 +0.0523140266 +0.0521773747 +0.0520376696 +0.051894897 +0.0517490425 +0.0516000917 +0.0514480304 +0.0512928443 +0.0511345192 +0.0509730408 +0.050808395 +0.0506405675 +0.0504695443 +0.0502953113 +0.0501178543 +0.0499371594 +0.0497532126 +0.0495659998 +0.0493755072 +0.0491817207 +0.0489846267 +0.0487842111 +0.0485804603 +0.0483733603 +0.0481628976 +0.0479490584 +0.047731829 +0.0475111958 +0.0472871453 +0.0470596638 +0.0468287379 +0.0465943541 +0.0463564989 +0.0461151591 +0.0458703211 +0.0456219717 +0.0453700977 +0.0451146858 +0.0448557228 +0.0445931957 +0.0443270912 +0.0440573963 +0.0437840981 +0.0435071835 +0.0432266396 +0.0429424537 +0.0426546128 +0.0423631041 +0.042067915 +0.0417690327 +0.0414664446 +0.0411601381 +0.0408501008 +0.04053632 +0.0402187834 +0.0398974785 +0.0395723931 +0.0392435149 +0.0389108315 +0.0385743309 +0.0382340009 +0.0378898295 +0.0375418045 +0.0371899142 +0.0368341464 +0.0364744895 +0.0361109316 +0.0357434609 +0.0353720658 +0.0349967347 +0.0346174559 +0.034234218 +0.0338470096 +0.0334558191 +0.0330606354 +0.0326614471 +0.032258243 +0.031851012 +0.0314397429 +0.0310244248 +0.0306050467 +0.0301815977 +0.0297540669 +0.0293224436 +0.0288867171 +0.0284468767 +0.0280029119 +0.0275548121 +0.0271025669 +0.0266461659 +0.0261855988 +0.0257208553 +0.0252519254 +0.0247787988 +0.0243014655 +0.0238199156 +0.0233341392 +0.0228441264 +0.0223498675 +0.0218513527 +0.0213485726 +0.0208415174 +0.0203301778 +0.0198145444 +0.0192946078 +0.0187703588 +0.0182417882 +0.0177088869 +0.0171716458 +0.0166300561 +0.0160841088 +0.0155337952 +0.0149791065 +0.0144200341 +0.0138565694 +0.0132887039 +0.0127164292 +0.0121397369 +0.0115586189 +0.010973067 +0.010383073 +0.00978862891 +0.00918972685 +0.00858635895 +0.00797851743 +0.0073661946 +0.00674938288 +0.00612807472 +0.0055022627 +0.00487193946 +0.00423709772 +0.00359773031 +0.00295383012 +0.00230539013 +0.00165240341 +0.000994863129 +0.000332762517 +0.000333905094 +0.00100514629 +0.00168096756 +0.00236137532 +0.00304637589 +0.0037359755 +0.00443018029 +0.00512899631 +0.00583242953 +0.00654048582 +0.00725317096 +0.00797049065 +0.00869245048 +0.00941905596 +0.0101503125 +0.0108862255 +0.0116268 +0.0123720414 +0.0131219545 +0.0138765444 +0.014635816 +0.0153997739 +0.0161684229 +0.0169417674 +0.0177198121 +0.0185025613 +0.0192900193 +0.0200821902 +0.0208790782 +0.0216806872 +0.0224870212 +0.0232980839 +0.0241138791 +0.0249344104 +0.0257596812 +0.026589695 +0.0274244551 +0.0282639647 +0.0291082269 +0.0299572447 +0.030811021 +0.0316695587 +0.0325328604 +0.0334009287 +0.0342737662 +0.0351513753 +0.0360337582 +0.0369209171 +0.0378128542 +0.0387095715 +0.0396110707 +0.0405173538 +0.0414284224 +0.042344278 +0.0432649222 +0.0441903564 +0.0451205816 +0.0460555993 +0.0469954103 +0.0479400157 +0.0488894162 +0.0498436127 +0.0508026057 +0.0517663958 +0.0527349834 +0.0537083688 +0.0546865522 +0.0556695337 +0.0566573133 +0.0576498908 +0.0586472661 +0.0596494388 +0.0606564085 +0.0616681745 +0.0626847363 +0.0637060931 +0.0647322439 +0.0657631878 +0.0667989237 +0.0678394504 +0.0688847666 +0.0699348708 +0.0709897614 +0.0720494369 +0.0731138955 +0.0741831353 +0.0752571542 +0.0763359503 +0.0774195212 +0.0785078648 +0.0796009785 +0.0806988597 +0.0818015059 +0.0829089143 +0.084021082 +0.0851380059 +0.0862596831 +0.0873861102 +0.0885172839 +0.0896532008 +0.0907938573 +0.0919392497 +0.0930893743 +0.0942442272 +0.0954038042 +0.0965681014 +0.0977371144 +0.0989108389 +0.10008927 +0.101272404 +0.102460236 +0.103652761 +0.104849973 +0.106051869 +0.107258442 +0.108469688 +0.109685601 +0.110906175 +0.112131406 +0.113361286 +0.114595811 +0.115834975 +0.11707877 +0.118327192 +0.119580234 +0.120837889 +0.12210015 +0.123367012 +0.124638468 +0.125914509 +0.12719513 +0.128480324 +0.129770083 +0.131064399 +0.132363265 +0.133666674 +0.134974618 +0.136287089 +0.13760408 +0.138925581 +0.140251585 +0.141582084 +0.142917069 +0.144256532 +0.145600464 +0.146948856 +0.148301699 +0.149658985 +0.151020704 +0.152386847 +0.153757405 +0.155132369 +0.156511727 +0.157895472 +0.159283593 +0.160676081 +0.162072924 +0.163474114 +0.16487964 +0.16628949 +0.167703656 +0.169122126 +0.17054489 +0.171971936 +0.173403254 +0.174838833 +0.176278661 +0.177722727 +0.17917102 +0.180623529 +0.18208024 +0.183541144 +0.185006227 +0.186475478 +0.187948885 +0.189426435 +0.190908116 +0.192393916 +0.193883822 +0.195377822 +0.196875902 +0.198378049 +0.199884252 +0.201394495 +0.202908767 +0.204427054 +0.205949342 +0.207475618 +0.209005867 +0.210540077 +0.212078233 +0.213620321 +0.215166328 +0.216716237 +0.218270037 +0.219827711 +0.221389245 +0.222954624 +0.224523835 +0.22609686 +0.227673687 +0.229254299 +0.23083868 +0.232426817 +0.234018693 +0.235614292 +0.237213599 +0.238816598 +0.240423274 +0.242033609 +0.243647588 +0.245265195 +0.246886412 +0.248511225 +0.250139615 +0.251771567 +0.253407063 +0.255046087 +0.256688621 +0.258334649 +0.259984153 +0.261637116 +0.26329352 +0.264953348 +0.266616581 +0.268283204 +0.269953196 +0.271626541 +0.27330322 +0.274983216 +0.276666509 +0.278353081 +0.280042915 +0.28173599 +0.28343229 +0.285131794 +0.286834483 +0.28854034 +0.290249344 +0.291961476 +0.293676717 +0.295395048 +0.297116449 +0.298840901 +0.300568383 +0.302298875 +0.304032359 +0.305768814 +0.307508219 +0.309250555 +0.310995801 +0.312743936 +0.314494941 +0.316248795 +0.318005476 +0.319764964 +0.321527238 +0.323292277 +0.32506006 +0.326830566 +0.328603774 +0.330379661 +0.332158207 +0.33393939 +0.335723188 +0.33750958 +0.339298543 +0.341090057 +0.342884097 +0.344680644 +0.346479673 +0.348281164 +0.350085093 +0.351891438 +0.353700177 +0.355511287 +0.357324745 +0.359140527 +0.360958613 +0.362778977 +0.364601597 +0.366426451 +0.368253514 +0.370082763 +0.371914175 +0.373747726 +0.375583393 +0.377421152 +0.379260979 +0.38110285 +0.382946742 +0.384792629 +0.386640489 +0.388490297 +0.390342028 +0.392195659 +0.394051164 +0.39590852 +0.397767701 +0.399628683 +0.401491442 +0.403355952 +0.405222188 +0.407090126 +0.40895974 +0.410831006 +0.412703898 +0.41457839 +0.416454458 +0.418332076 +0.420211218 +0.422091859 +0.423973974 +0.425857536 +0.427742519 +0.429628898 +0.431516648 +0.433405741 +0.435296151 +0.437187854 +0.439080822 +0.440975029 +0.442870449 +0.444767055 +0.446664821 +0.44856372 +0.450463727 +0.452364813 +0.454266952 +0.456170119 +0.458074284 +0.459979423 +0.461885507 +0.46379251 +0.465700404 +0.467609163 +0.46951876 +0.471429166 +0.473340354 +0.475252298 +0.477164969 +0.479078341 +0.480992385 +0.482907074 +0.484822381 +0.486738277 +0.488654735 +0.490571727 +0.492489225 +0.494407201 +0.496325627 +0.498244475 +0.500163717 +0.502083325 +0.504003271 +0.505923526 +0.507844062 +0.50976485 +0.511685864 +0.513607073 +0.515528449 +0.517449965 +0.519371591 +0.521293298 +0.523215059 +0.525136844 +0.527058625 +0.528980373 +0.530902059 +0.532823654 +0.534745129 +0.536666456 +0.538587605 +0.540508548 +0.542429255 +0.544349698 +0.546269846 +0.548189672 +0.550109146 +0.552028238 +0.55394692 +0.555865161 +0.557782934 +0.559700208 +0.561616954 +0.563533143 +0.565448745 +0.567363731 +0.569278071 +0.571191736 +0.573104696 +0.575016922 +0.576928383 +0.578839052 +0.580748897 +0.582657889 +0.584565999 +0.586473196 +0.588379452 +0.590284735 +0.592189018 +0.594092269 +0.595994458 +0.597895557 +0.599795535 +0.601694363 +0.60359201 +0.605488446 +0.607383643 +0.609277569 +0.611170195 +0.613061491 +0.614951426 +0.616839972 +0.618727098 +0.620612773 +0.622496969 +0.624379655 +0.626260801 +0.628140376 +0.630018352 +0.631894697 +0.633769383 +0.635642378 +0.637513653 +0.639383178 +0.641250922 +0.643116856 +0.64498095 +0.646843173 +0.648703496 +0.650561888 +0.652418319 +0.65427276 +0.65612518 +0.657975549 +0.659823837 +0.661670015 +0.663514052 +0.665355917 +0.667195582 +0.669033016 +0.670868189 +0.672701071 +0.674531632 +0.676359843 +0.678185672 +0.680009091 +0.68183007 +0.683648577 +0.685464584 +0.687278061 +0.689088977 +0.690897304 +0.69270301 +0.694506067 +0.696306444 +0.698104112 +0.69989904 +0.7016912 +0.703480561 +0.705267094 +0.707050769 +0.708831556 +0.710609426 +0.712384349 +0.714156295 +0.715925236 +0.717691141 +0.719453981 +0.721213726 +0.722970348 +0.724723816 +0.726474101 +0.728221174 +0.729965006 +0.731705567 +0.733442827 +0.735176759 +0.736907332 +0.738634517 +0.740358286 +0.742078609 +0.743795457 +0.745508801 +0.747218612 +0.748924862 +0.75062752 +0.75232656 +0.75402195 +0.755713664 +0.757401672 +0.759085945 +0.760766455 +0.762443173 +0.76411607 +0.765785119 +0.767450291 +0.769111556 +0.770768888 +0.772422257 +0.774071635 +0.775716994 +0.777358306 +0.778995543 +0.780628676 +0.782257678 +0.783882521 +0.785503177 +0.787119617 +0.788731814 +0.790339741 +0.79194337 +0.793542672 +0.795137621 +0.796728189 +0.798314348 +0.799896071 +0.801473331 +0.803046101 +0.804614353 +0.806178059 +0.807737194 +0.80929173 +0.81084164 +0.812386896 +0.813927473 +0.815463344 +0.816994481 +0.818520858 +0.820042449 +0.821559227 +0.823071166 +0.824578239 +0.82608042 +0.827577682 +0.829070001 +0.830557348 +0.8320397 +0.833517029 +0.83498931 +0.836456516 +0.837918623 +0.839375605 +0.840827436 +0.84227409 +0.843715543 +0.845151769 +0.846582742 +0.848008438 +0.849428831 +0.850843897 +0.85225361 +0.853657947 +0.855056881 +0.856450388 +0.857838444 +0.859221024 +0.860598104 +0.86196966 +0.863335667 +0.8646961 +0.866050937 +0.867400153 +0.868743724 +0.870081627 +0.871413837 +0.872740331 +0.874061086 +0.875376077 +0.876685283 +0.877988679 +0.879286242 +0.880577949 +0.881863778 +0.883143705 +0.884417708 +0.885685764 +0.88694785 +0.888203944 +0.889454023 +0.890698066 +0.891936049 +0.893167952 +0.894393751 +0.895613425 +0.896826953 +0.898034312 +0.899235481 +0.900430438 +0.901619162 +0.902801633 +0.903977827 +0.905147725 +0.906311306 +0.907468549 +0.908619432 +0.909763936 +0.910902039 +0.912033722 +0.913158963 +0.914277744 +0.915390043 +0.91649584 +0.917595117 +0.918687852 +0.919774027 +0.920853621 +0.921926616 +0.922992992 +0.924052729 +0.925105809 +0.926152213 +0.927191922 +0.928224916 +0.929251178 +0.930270689 +0.93128343 +0.932289384 +0.933288531 +0.934280854 +0.935266336 +0.936244957 +0.937216701 +0.938181549 +0.939139485 +0.940090491 +0.94103455 +0.941971645 +0.942901758 +0.943824873 +0.944740973 +0.945650041 +0.946552062 +0.947447018 +0.948334894 +0.949215673 +0.950089339 +0.950955876 +0.951815269 +0.952667502 +0.95351256 +0.954350427 +0.955181087 +0.956004527 +0.95682073 +0.957629682 +0.958431369 +0.959225775 +0.960012886 +0.960792688 +0.961565167 +0.962330308 +0.963088097 +0.963838522 +0.964581567 +0.965317221 +0.966045468 +0.966766296 +0.967479691 +0.968185641 +0.968884133 +0.969575154 +0.970258692 +0.970934733 +0.971603265 +0.972264277 +0.972917756 +0.97356369 +0.974202068 +0.974832878 +0.975456107 +0.976071746 +0.976679782 +0.977280204 +0.977873002 +0.978458164 +0.979035681 +0.97960554 +0.980167733 +0.980722247 +0.981269075 +0.981808204 +0.982339626 +0.982863331 +0.983379309 +0.98388755 +0.984388046 +0.984880787 +0.985365764 +0.985842968 +0.986312391 +0.986774023 +0.987227857 +0.987673884 +0.988112096 +0.988542484 +0.988965042 +0.98937976 +0.989786632 +0.99018565 +0.990576807 +0.990960095 +0.991335508 +0.991703038 +0.992062679 +0.992414424 +0.992758267 +0.993094202 +0.993422222 +0.99374232 +0.994054493 +0.994358732 +0.994655034 +0.994943392 +0.995223802 +0.995496257 +0.995760754 +0.996017287 +0.996265851 +0.996506442 +0.996739055 +0.996963687 +0.997180333 +0.997388989 +0.997589651 +0.997782315 +0.997966979 +0.998143638 +0.998312289 +0.99847293 +0.998625557 +0.998770167 +0.998906758 +0.999035327 +0.999155873 +0.999268391 +0.999372882 +0.999469342 +0.99955777 +0.999638164 +0.999710524 +0.999774846 +0.999831131 +0.999879377 +0.999919583 +0.999951749 +0.999975875 +0.999991958 +1 +1 +0.999991958 +0.999975875 +0.999951749 +0.999919583 +0.999879377 +0.999831131 +0.999774846 +0.999710524 +0.999638164 +0.99955777 +0.999469342 +0.999372882 +0.999268391 +0.999155873 +0.999035327 +0.998906758 +0.998770167 +0.998625557 +0.99847293 +0.998312289 +0.998143638 +0.997966979 +0.997782315 +0.997589651 +0.997388989 +0.997180333 +0.996963687 +0.996739055 +0.996506442 +0.996265851 +0.996017287 +0.995760754 +0.995496257 +0.995223802 +0.994943392 +0.994655034 +0.994358732 +0.994054493 +0.99374232 +0.993422222 +0.993094202 +0.992758267 +0.992414424 +0.992062679 +0.991703038 +0.991335508 +0.990960095 +0.990576807 +0.99018565 +0.989786632 +0.98937976 +0.988965042 +0.988542484 +0.988112096 +0.987673884 +0.987227857 +0.986774023 +0.986312391 +0.985842968 +0.985365764 +0.984880787 +0.984388046 +0.98388755 +0.983379309 +0.982863331 +0.982339626 +0.981808204 +0.981269075 +0.980722247 +0.980167733 +0.97960554 +0.979035681 +0.978458164 +0.977873002 +0.977280204 +0.976679782 +0.976071746 +0.975456107 +0.974832878 +0.974202068 +0.97356369 +0.972917756 +0.972264277 +0.971603265 +0.970934733 +0.970258692 +0.969575154 +0.968884133 +0.968185641 +0.967479691 +0.966766296 +0.966045468 +0.965317221 +0.964581567 +0.963838522 +0.963088097 +0.962330308 +0.961565167 +0.960792688 +0.960012886 +0.959225775 +0.958431369 +0.957629682 +0.95682073 +0.956004527 +0.955181087 +0.954350427 +0.95351256 +0.952667502 +0.951815269 +0.950955876 +0.950089339 +0.949215673 +0.948334894 +0.947447018 +0.946552062 +0.945650041 +0.944740973 +0.943824873 +0.942901758 +0.941971645 +0.94103455 +0.940090491 +0.939139485 +0.938181549 +0.937216701 +0.936244957 +0.935266336 +0.934280854 +0.933288531 +0.932289384 +0.93128343 +0.930270689 +0.929251178 +0.928224916 +0.927191922 +0.926152213 +0.925105809 +0.924052729 +0.922992992 +0.921926616 +0.920853621 +0.919774027 +0.918687852 +0.917595117 +0.91649584 +0.915390043 +0.914277744 +0.913158963 +0.912033722 +0.910902039 +0.909763936 +0.908619432 +0.907468549 +0.906311306 +0.905147725 +0.903977827 +0.902801633 +0.901619162 +0.900430438 +0.899235481 +0.898034312 +0.896826953 +0.895613425 +0.894393751 +0.893167952 +0.891936049 +0.890698066 +0.889454023 +0.888203944 +0.88694785 +0.885685764 +0.884417708 +0.883143705 +0.881863778 +0.880577949 +0.879286242 +0.877988679 +0.876685283 +0.875376077 +0.874061086 +0.872740331 +0.871413837 +0.870081627 +0.868743724 +0.867400153 +0.866050937 +0.8646961 +0.863335667 +0.86196966 +0.860598104 +0.859221024 +0.857838444 +0.856450388 +0.855056881 +0.853657947 +0.85225361 +0.850843897 +0.849428831 +0.848008438 +0.846582742 +0.845151769 +0.843715543 +0.84227409 +0.840827436 +0.839375605 +0.837918623 +0.836456516 +0.83498931 +0.833517029 +0.8320397 +0.830557348 +0.829070001 +0.827577682 +0.82608042 +0.824578239 +0.823071166 +0.821559227 +0.820042449 +0.818520858 +0.816994481 +0.815463344 +0.813927473 +0.812386896 +0.81084164 +0.80929173 +0.807737194 +0.806178059 +0.804614353 +0.803046101 +0.801473331 +0.799896071 +0.798314348 +0.796728189 +0.795137621 +0.793542672 +0.79194337 +0.790339741 +0.788731814 +0.787119617 +0.785503177 +0.783882521 +0.782257678 +0.780628676 +0.778995543 +0.777358306 +0.775716994 +0.774071635 +0.772422257 +0.770768888 +0.769111556 +0.767450291 +0.765785119 +0.76411607 +0.762443173 +0.760766455 +0.759085945 +0.757401672 +0.755713664 +0.75402195 +0.75232656 +0.75062752 +0.748924862 +0.747218612 +0.745508801 +0.743795457 +0.742078609 +0.740358286 +0.738634517 +0.736907332 +0.735176759 +0.733442827 +0.731705567 +0.729965006 +0.728221174 +0.726474101 +0.724723816 +0.722970348 +0.721213726 +0.719453981 +0.717691141 +0.715925236 +0.714156295 +0.712384349 +0.710609426 +0.708831556 +0.707050769 +0.705267094 +0.703480561 +0.7016912 +0.69989904 +0.698104112 +0.696306444 +0.694506067 +0.69270301 +0.690897304 +0.689088977 +0.687278061 +0.685464584 +0.683648577 +0.68183007 +0.680009091 +0.678185672 +0.676359843 +0.674531632 +0.672701071 +0.670868189 +0.669033016 +0.667195582 +0.665355917 +0.663514052 +0.661670015 +0.659823837 +0.657975549 +0.65612518 +0.65427276 +0.652418319 +0.650561888 +0.648703496 +0.646843173 +0.64498095 +0.643116856 +0.641250922 +0.639383178 +0.637513653 +0.635642378 +0.633769383 +0.631894697 +0.630018352 +0.628140376 +0.626260801 +0.624379655 +0.622496969 +0.620612773 +0.618727098 +0.616839972 +0.614951426 +0.613061491 +0.611170195 +0.609277569 +0.607383643 +0.605488446 +0.60359201 +0.601694363 +0.599795535 +0.597895557 +0.595994458 +0.594092269 +0.592189018 +0.590284735 +0.588379452 +0.586473196 +0.584565999 +0.582657889 +0.580748897 +0.578839052 +0.576928383 +0.575016922 +0.573104696 +0.571191736 +0.569278071 +0.567363731 +0.565448745 +0.563533143 +0.561616954 +0.559700208 +0.557782934 +0.555865161 +0.55394692 +0.552028238 +0.550109146 +0.548189672 +0.546269846 +0.544349698 +0.542429255 +0.540508548 +0.538587605 +0.536666456 +0.534745129 +0.532823654 +0.530902059 +0.528980373 +0.527058625 +0.525136844 +0.523215059 +0.521293298 +0.519371591 +0.517449965 +0.515528449 +0.513607073 +0.511685864 +0.50976485 +0.507844062 +0.505923526 +0.504003271 +0.502083325 +0.500163717 +0.498244475 +0.496325627 +0.494407201 +0.492489225 +0.490571727 +0.488654735 +0.486738277 +0.484822381 +0.482907074 +0.480992385 +0.479078341 +0.477164969 +0.475252298 +0.473340354 +0.471429166 +0.46951876 +0.467609163 +0.465700404 +0.46379251 +0.461885507 +0.459979423 +0.458074284 +0.456170119 +0.454266952 +0.452364813 +0.450463727 +0.44856372 +0.446664821 +0.444767055 +0.442870449 +0.440975029 +0.439080822 +0.437187854 +0.435296151 +0.433405741 +0.431516648 +0.429628898 +0.427742519 +0.425857536 +0.423973974 +0.422091859 +0.420211218 +0.418332076 +0.416454458 +0.41457839 +0.412703898 +0.410831006 +0.40895974 +0.407090126 +0.405222188 +0.403355952 +0.401491442 +0.399628683 +0.397767701 +0.39590852 +0.394051164 +0.392195659 +0.390342028 +0.388490297 +0.386640489 +0.384792629 +0.382946742 +0.38110285 +0.379260979 +0.377421152 +0.375583393 +0.373747726 +0.371914175 +0.370082763 +0.368253514 +0.366426451 +0.364601597 +0.362778977 +0.360958613 +0.359140527 +0.357324745 +0.355511287 +0.353700177 +0.351891438 +0.350085093 +0.348281164 +0.346479673 +0.344680644 +0.342884097 +0.341090057 +0.339298543 +0.33750958 +0.335723188 +0.33393939 +0.332158207 +0.330379661 +0.328603774 +0.326830566 +0.32506006 +0.323292277 +0.321527238 +0.319764964 +0.318005476 +0.316248795 +0.314494941 +0.312743936 +0.310995801 +0.309250555 +0.307508219 +0.305768814 +0.304032359 +0.302298875 +0.300568383 +0.298840901 +0.297116449 +0.295395048 +0.293676717 +0.291961476 +0.290249344 +0.28854034 +0.286834483 +0.285131794 +0.28343229 +0.28173599 +0.280042915 +0.278353081 +0.276666509 +0.274983216 +0.27330322 +0.271626541 +0.269953196 +0.268283204 +0.266616581 +0.264953348 +0.26329352 +0.261637116 +0.259984153 +0.258334649 +0.256688621 +0.255046087 +0.253407063 +0.251771567 +0.250139615 +0.248511225 +0.246886412 +0.245265195 +0.243647588 +0.242033609 +0.240423274 +0.238816598 +0.237213599 +0.235614292 +0.234018693 +0.232426817 +0.23083868 +0.229254299 +0.227673687 +0.22609686 +0.224523835 +0.222954624 +0.221389245 +0.219827711 +0.218270037 +0.216716237 +0.215166328 +0.213620321 +0.212078233 +0.210540077 +0.209005867 +0.207475618 +0.205949342 +0.204427054 +0.202908767 +0.201394495 +0.199884252 +0.198378049 +0.196875902 +0.195377822 +0.193883822 +0.192393916 +0.190908116 +0.189426435 +0.187948885 +0.186475478 +0.185006227 +0.183541144 +0.18208024 +0.180623529 +0.17917102 +0.177722727 +0.176278661 +0.174838833 +0.173403254 +0.171971936 +0.17054489 +0.169122126 +0.167703656 +0.16628949 +0.16487964 +0.163474114 +0.162072924 +0.160676081 +0.159283593 +0.157895472 +0.156511727 +0.155132369 +0.153757405 +0.152386847 +0.151020704 +0.149658985 +0.148301699 +0.146948856 +0.145600464 +0.144256532 +0.142917069 +0.141582084 +0.140251585 +0.138925581 +0.13760408 +0.136287089 +0.134974618 +0.133666674 +0.132363265 +0.131064399 +0.129770083 +0.128480324 +0.12719513 +0.125914509 +0.124638468 +0.123367012 +0.12210015 +0.120837889 +0.119580234 +0.118327192 +0.11707877 +0.115834975 +0.114595811 +0.113361286 +0.112131406 +0.110906175 +0.109685601 +0.108469688 +0.107258442 +0.106051869 +0.104849973 +0.103652761 +0.102460236 +0.101272404 +0.10008927 +0.0989108389 +0.0977371144 +0.0965681014 +0.0954038042 +0.0942442272 +0.0930893743 +0.0919392497 +0.0907938573 +0.0896532008 +0.0885172839 +0.0873861102 +0.0862596831 +0.0851380059 +0.084021082 +0.0829089143 +0.0818015059 +0.0806988597 +0.0796009785 +0.0785078648 +0.0774195212 +0.0763359503 +0.0752571542 +0.0741831353 +0.0731138955 +0.0720494369 +0.0709897614 +0.0699348708 +0.0688847666 +0.0678394504 +0.0667989237 +0.0657631878 +0.0647322439 +0.0637060931 +0.0626847363 +0.0616681745 +0.0606564085 +0.0596494388 +0.0586472661 +0.0576498908 +0.0566573133 +0.0556695337 +0.0546865522 +0.0537083688 +0.0527349834 +0.0517663958 +0.0508026057 +0.0498436127 +0.0488894162 +0.0479400157 +0.0469954103 +0.0460555993 +0.0451205816 +0.0441903564 +0.0432649222 +0.042344278 +0.0414284224 +0.0405173538 +0.0396110707 +0.0387095715 +0.0378128542 +0.0369209171 +0.0360337582 +0.0351513753 +0.0342737662 +0.0334009287 +0.0325328604 +0.0316695587 +0.030811021 +0.0299572447 +0.0291082269 +0.0282639647 +0.0274244551 +0.026589695 +0.0257596812 +0.0249344104 +0.0241138791 +0.0232980839 +0.0224870212 +0.0216806872 +0.0208790782 +0.0200821902 +0.0192900193 +0.0185025613 +0.0177198121 +0.0169417674 +0.0161684229 +0.0153997739 +0.014635816 +0.0138765444 +0.0131219545 +0.0123720414 +0.0116268 +0.0108862255 +0.0101503125 +0.00941905596 +0.00869245048 +0.00797049065 +0.00725317096 +0.00654048582 +0.00583242953 +0.00512899631 +0.00443018029 +0.0037359755 +0.00304637589 +0.00236137532 +0.00168096756 +0.00100514629 +0.000333905094 +0.000332762517 +0.000994863129 +0.00165240341 +0.00230539013 +0.00295383012 +0.00359773031 +0.00423709772 +0.00487193946 +0.0055022627 +0.00612807472 +0.00674938288 +0.0073661946 +0.00797851743 +0.00858635895 +0.00918972685 +0.00978862891 +0.010383073 +0.010973067 +0.0115586189 +0.0121397369 +0.0127164292 +0.0132887039 +0.0138565694 +0.0144200341 +0.0149791065 +0.0155337952 +0.0160841088 +0.0166300561 +0.0171716458 +0.0177088869 +0.0182417882 +0.0187703588 +0.0192946078 +0.0198145444 +0.0203301778 +0.0208415174 +0.0213485726 +0.0218513527 +0.0223498675 +0.0228441264 +0.0233341392 +0.0238199156 +0.0243014655 +0.0247787988 +0.0252519254 +0.0257208553 +0.0261855988 +0.0266461659 +0.0271025669 +0.0275548121 +0.0280029119 +0.0284468767 +0.0288867171 +0.0293224436 +0.0297540669 +0.0301815977 +0.0306050467 +0.0310244248 +0.0314397429 +0.031851012 +0.032258243 +0.0326614471 +0.0330606354 +0.0334558191 +0.0338470096 +0.034234218 +0.0346174559 +0.0349967347 +0.0353720658 +0.0357434609 +0.0361109316 +0.0364744895 +0.0368341464 +0.0371899142 +0.0375418045 +0.0378898295 +0.0382340009 +0.0385743309 +0.0389108315 +0.0392435149 +0.0395723931 +0.0398974785 +0.0402187834 +0.04053632 +0.0408501008 +0.0411601381 +0.0414664446 +0.0417690327 +0.042067915 +0.0423631041 +0.0426546128 +0.0429424537 +0.0432266396 +0.0435071835 +0.0437840981 +0.0440573963 +0.0443270912 +0.0445931957 +0.0448557228 +0.0451146858 +0.0453700977 +0.0456219717 +0.0458703211 +0.0461151591 +0.0463564989 +0.0465943541 +0.0468287379 +0.0470596638 +0.0472871453 +0.0475111958 +0.047731829 +0.0479490584 +0.0481628976 +0.0483733603 +0.0485804603 +0.0487842111 +0.0489846267 +0.0491817207 +0.0493755072 +0.0495659998 +0.0497532126 +0.0499371594 +0.0501178543 +0.0502953113 +0.0504695443 +0.0506405675 +0.050808395 +0.0509730408 +0.0511345192 +0.0512928443 +0.0514480304 +0.0516000917 +0.0517490425 +0.051894897 +0.0520376696 +0.0521773747 +0.0523140266 +0.0524476398 +0.0525782286 +0.0527058076 +0.0528303911 +0.0529519938 +0.05307063 +0.0531863145 +0.0532990617 +0.0534088862 +0.0535158026 +0.0536198256 +0.0537209699 +0.05381925 +0.0539146807 +0.0540072766 +0.0540970526 +0.0541840233 +0.0542682036 +0.0543496081 +0.0544282517 +0.0545041492 +0.0545773154 +0.0546477651 +0.0547155132 +0.0547805746 +0.0548429641 +0.0549026966 +0.0549597871 +0.0550142504 +0.0550661015 +0.0551153553 +0.0551620267 +0.0552061307 +0.0552476823 +0.0552866965 +0.0553231882 +0.0553571723 +0.055388664 +0.0554176782 +0.05544423 +0.0554683342 +0.0554900061 +0.0555092605 +0.0555261126 +0.0555405773 +0.0555526697 +0.0555624048 +0.0555697977 +0.0555748635 +0.0555776171 +0.0555780737 +0.0555762482 +0.0555721558 +0.0555658114 +0.0555572302 +0.0555464272 +0.0555334174 +0.0555182158 +0.0555008376 +0.0554812978 +0.0554596113 +0.0554357933 +0.0554098587 +0.0553818226 +0.0553517 +0.0553195059 +0.0552852554 +0.0552489633 +0.0552106448 +0.0551703148 +0.0551279883 +0.0550836803 +0.0550374056 +0.0549891794 +0.0549390164 +0.0548869318 +0.0548329402 +0.0547770568 +0.0547192964 +0.0546596738 +0.054598204 +0.0545349019 +0.0544697821 +0.0544028598 +0.0543341495 +0.0542636662 +0.0541914246 +0.0541174396 +0.0540417258 +0.0539642981 +0.0538851712 +0.0538043597 +0.0537218785 +0.0536377421 +0.0535519652 +0.0534645625 +0.0533755486 +0.0532849381 +0.0531927456 +0.0530989857 +0.0530036729 +0.0529068218 +0.0528084467 +0.0527085623 +0.052607183 +0.0525043232 +0.0523999974 +0.0522942199 +0.052187005 +0.0520783673 +0.0519683209 +0.0518568802 +0.0517440594 +0.0516298728 +0.0515143346 +0.051397459 +0.0512792601 +0.0511597522 +0.0510389492 +0.0509168654 +0.0507935148 +0.0506689113 +0.050543069 +0.0504160018 +0.0502877238 +0.0501582488 +0.0500275906 +0.0498957632 +0.0497627804 +0.0496286559 +0.0494934035 +0.0493570369 +0.0492195698 +0.049081016 +0.0489413889 +0.0488007022 +0.0486589695 +0.0485162042 +0.0483724199 +0.0482276301 +0.0480818481 +0.0479350873 +0.0477873611 +0.0476386828 +0.0474890656 +0.0473385229 +0.0471870678 +0.0470347135 +0.046881473 +0.0467273596 +0.0465723862 +0.0464165659 +0.0462599117 +0.0461024364 +0.045944153 +0.0457850743 +0.0456252131 +0.0454645823 +0.0453031945 +0.0451410625 +0.0449781989 +0.0448146163 +0.0446503273 +0.0444853444 +0.0443196801 +0.0441533468 +0.043986357 +0.043818723 +0.0436504571 +0.0434815715 +0.0433120786 +0.0431419904 +0.0429713192 +0.042800077 +0.0426282758 +0.0424559277 +0.0422830446 +0.0421096384 +0.041935721 +0.0417613042 +0.0415863998 +0.0414110195 +0.0412351749 +0.0410588778 +0.0408821396 +0.040704972 +0.0405273863 +0.0403493941 +0.0401710067 +0.0399922355 +0.0398130917 +0.0396335866 +0.0394537315 +0.0392735373 +0.0390930153 +0.0389121764 +0.0387310317 +0.0385495921 +0.0383678685 +0.0381858718 +0.0380036126 +0.0378211018 +0.0376383501 +0.037455368 +0.0372721662 +0.0370887552 +0.0369051454 +0.0367213474 +0.0365373714 +0.0363532278 +0.0361689269 +0.0359844789 +0.0357998938 +0.035615182 +0.0354303533 +0.0352454177 +0.0350603854 +0.034875266 +0.0346900696 +0.0345048057 +0.0343194843 +0.0341341149 +0.0339487071 +0.0337632706 +0.0335778148 +0.0333923492 +0.0332068831 +0.033021426 +0.0328359871 +0.0326505757 +0.0324652008 +0.0322798717 +0.0320945973 +0.0319093867 +0.0317242489 +0.0315391926 +0.0313542268 +0.0311693603 +0.0309846017 +0.0307999597 +0.0306154429 +0.0304310599 +0.0302468191 +0.030062729 +0.0298787979 +0.0296950342 +0.0295114461 +0.0293280419 +0.0291448296 +0.0289618173 +0.0287790131 +0.028596425 +0.0284140608 +0.0282319284 +0.0280500355 +0.02786839 +0.0276869995 +0.0275058715 +0.0273250137 +0.0271444336 +0.0269641386 +0.026784136 +0.0266044332 +0.0264250374 +0.0262459559 +0.0260671957 +0.025888764 +0.0257106678 +0.0255329141 +0.0253555097 +0.0251784614 +0.0250017762 +0.0248254606 +0.0246495214 +0.0244739651 +0.0242987984 +0.0241240276 +0.0239496593 +0.0237756997 +0.0236021552 +0.023429032 +0.0232563364 +0.0230840744 +0.022912252 +0.0227408754 +0.0225699504 +0.022399483 +0.0222294789 +0.0220599439 +0.0218908838 +0.0217223041 +0.0215542105 +0.0213866084 +0.0212195035 +0.0210529009 +0.0208868062 +0.0207212245 +0.0205561611 +0.0203916212 +0.0202276099 +0.0200641322 +0.0199011931 +0.0197387976 +0.0195769504 +0.0194156565 +0.0192549205 +0.0190947471 +0.018935141 +0.0187761068 +0.0186176488 +0.0184597717 +0.0183024798 +0.0181457774 +0.0179896688 +0.0178341581 +0.0176792496 +0.0175249474 +0.0173712555 +0.0172181778 +0.0170657182 +0.0169138808 +0.0167626691 +0.016612087 +0.0164621382 +0.0163128262 +0.0161641547 +0.0160161271 +0.0158687469 +0.0157220175 +0.0155759422 +0.0154305243 +0.0152857671 +0.0151416736 +0.0149982469 +0.0148554902 +0.0147134063 +0.0145719983 +0.0144312689 +0.0142912211 +0.0141518575 +0.0140131809 +0.0138751939 +0.013737899 +0.0136012989 +0.013465396 +0.0133301926 +0.0131956912 +0.0130618941 +0.0129288035 +0.0127964215 +0.0126647504 +0.0125337923 +0.012403549 +0.0122740227 +0.0121452151 +0.0120171282 +0.0118897639 +0.0117631237 +0.0116372094 +0.0115120227 +0.0113875651 +0.0112638382 +0.0111408434 +0.0110185822 +0.0108970559 +0.0107762659 +0.0106562134 +0.0105368995 +0.0104183255 +0.0103004925 +0.0101834015 +0.0100670535 +0.00995144942 +0.00983659019 +0.00972247662 +0.00960910951 +0.00949648959 +0.00938461754 +0.009273494 +0.00916311953 +0.00905349466 +0.00894461988 +0.00883649561 +0.00872912223 +0.00862250005 +0.00851662936 +0.00841151037 +0.00830714327 +0.00820352817 +0.00810066516 +0.00799855425 +0.00789719543 +0.00779658862 +0.00769673371 +0.00759763052 +0.00749927883 +0.00740167838 +0.00730482887 +0.00720872992 +0.00711338112 +0.00701878203 +0.00692493214 +0.0068318309 +0.00673947771 +0.00664787193 +0.00655701287 +0.0064668998 +0.00637753194 +0.00628890846 +0.00620102849 +0.00611389112 +0.00602749537 +0.00594184025 +0.00585692471 +0.00577274766 +0.00568930794 +0.00560660439 +0.00552463578 +0.00544340083 +0.00536289824 +0.00528312666 +0.00520408468 +0.00512577087 +0.00504818374 +0.00497132178 +0.00489518341 +0.00481976704 +0.00474507101 +0.00467109365 +0.00459783321 +0.00452528793 +0.00445345601 +0.0043823356 +0.0043119248 +0.00424222169 +0.0041732243 +0.00410493063 +0.00403733864 +0.00397044624 +0.00390425132 +0.0038387517 +0.00377394521 +0.00370982961 +0.00364640262 +0.00358366195 +0.00352160525 +0.00346023013 +0.00339953419 +0.00333951498 +0.00328017001 +0.00322149675 +0.00316349266 +0.00310615513 +0.00304948156 +0.00299346927 +0.00293811558 +0.00288341775 +0.00282937304 +0.00277597864 +0.00272323174 +0.00267112947 +0.00261966894 +0.00256884724 +0.00251866141 +0.00246910847 +0.00242018539 +0.00237188914 +0.00232421664 +0.00227716478 +0.00223073043 +0.00218491041 +0.00213970154 +0.00209510058 +0.00205110429 +0.00200770937 +0.00196491254 +0.00192271043 +0.0018810997 +0.00184007694 +0.00179963874 +0.00175978164 +0.00172050218 +0.00168179686 +0.00164366214 +0.00160609449 +0.00156909032 +0.00153264603 +0.001496758 +0.00146142258 +0.00142663608 +0.00139239482 +0.00135869507 +0.00132553309 +0.0012929051 +0.00126080731 +0.00122923593 +0.00119818709 +0.00116765696 +0.00113764165 +0.00110813726 +0.00107913988 +0.00105064555 +0.00102265032 +0.000995150203 +0.000968141203 +0.000941619297 +0.000915580444 +0.000890020586 +0.000864935645 +0.000840321525 +0.000816174114 +0.000792489279 +0.000769262873 +0.000746490729 +0.000724168666 +0.000702292483 +0.000680857968 +0.000659860888 +0.000639296997 +0.000619162034 +0.000599451722 +0.000580161769 +0.000561287871 +0.000542825708 +0.000524770946 +0.000507119238 +0.000489866224 +0.000473007532 +0.000456538775 +0.000440455557 +0.000424753467 +0.000409428083 +0.000394474974 +0.000379889695 +0.000365667792 +0.000351804799 +0.000338296241 +0.000325137633 +0.000312324481 +0.000299852279 +0.000287716515 +0.000275912667 +0.000264436206 +0.000253282591 +0.000242447278 +0.000231925713 +0.000221713335 +0.000211805575 +0.000202197861 +0.00019288561 +0.000183864235 +0.000175129145 +0.000166675742 +0.000158499421 +0.000150595575 +0.000142959591 +0.000135586852 +0.000128472737 +0.000121612621 +0.000115001876 +0.000108635872 +0.000102509973 +9.66195432e-05 +9.09599435e-05 +8.5526533e-05 +8.0314669e-05 +7.53197076e-05 +7.05370036e-05 +6.59619109e-05 +6.15897832e-05 +5.74159736e-05 +5.34358353e-05 +4.96447219e-05 +4.60379876e-05 +4.26109873e-05 +3.93590773e-05 +3.6277615e-05 +3.33619599e-05 +3.06074732e-05 +2.80095185e-05 +2.5563462e-05 +2.32646727e-05 +2.11085226e-05 +1.90903871e-05 +1.72056456e-05 +1.54496809e-05 +1.38178804e-05 +1.23056359e-05 +1.09083439e-05 +9.62140598e-06 +8.44022899e-06 +7.36022539e-06 +6.37681346e-06 +5.48541761e-06 +4.68146863e-06 +3.96040395e-06 +3.31766794e-06 +2.74871213e-06 +2.24899552e-06 +1.81398481e-06 +1.43915468e-06 +1.11998804e-06 +8.51976334e-07 +6.30619731e-07 +4.51427445e-07 +3.09917965e-07 +2.01619321e-07 +1.22069341e-07 +6.68159063e-08 +3.14172076e-08 +1.14419998e-08 +2.46985517e-09 +9.14157145e-11 + +shape_id 4 +num_samples 3000 +0.5 +0 +0 +747 +-0.5 +0 +0 +1497 +0.5 +0 +0 +747 + +shape_id 5 +num_samples 3976 +0.0234017164 +0.0507674335 +0.0394620655 +-0.000413859538 +-0.0480379501 +-0.0856381126 +-0.102813914 +-0.0964527359 +-0.0690952913 +-0.0269549385 +0.0220280519 +0.0697477884 +0.109161365 +0.135045273 +0.144390036 +0.136447095 +0.112533189 +0.0756342738 +0.029901407 +-0.0198616373 +-0.0687443993 +-0.112190922 +-0.146357131 +-0.168416199 +-0.17666749 +-0.170641092 +-0.150997937 +-0.119441441 +-0.0784910287 +-0.0312381716 +0.0188365421 +0.068231916 +0.113587151 +0.151929467 +0.1808277 +0.198531344 +0.204044059 +0.197142552 +0.178353468 +0.148881254 +0.110528964 +0.0655658008 +0.0165291335 +-0.0338247226 +-0.082787962 +-0.127757406 +-0.166401783 +-0.196783799 +-0.217419623 +-0.227337363 +-0.226123918 +-0.213913836 +-0.191366038 +-0.159615435 +-0.120180352 +-0.0749800977 +-0.0260465728 +0.0243599131 +0.0739936085 +0.120688986 +0.162433175 +0.197473197 +0.224350021 +0.24197348 +0.249681723 +0.247193763 +0.234673413 +0.212668382 +0.182097961 +0.144208253 +0.10051458 +0.0527349372 +0.0027175714 +-0.0476982653 +-0.0965022849 +-0.142022503 +-0.182488019 +-0.216505556 +-0.242870799 +-0.26065985 +-0.269277023 +-0.268463761 +-0.258278641 +-0.239119833 +-0.211686335 +-0.176938405 +-0.136051893 +-0.0904894747 +-0.0416846397 +0.0086439869 +0.058887777 +0.10745639 +0.152715027 +0.193264838 +0.227835367 +0.255355936 +0.27498899 +0.286152392 +0.288533034 +0.282077671 +0.267023737 +0.243863624 +0.213272829 +0.176262647 +0.133869619 +0.0874489466 +0.0382448375 +-0.0121664793 +-0.0623983945 +-0.111030683 +-0.156644006 +-0.197953929 +-0.233824932 +-0.263267784 +-0.285481404 +-0.299872528 +-0.306069114 +-0.303926857 +-0.293514608 +-0.275154004 +-0.249363223 +-0.216827718 +-0.178439996 +-0.135272517 +-0.0883598653 +-0.0390990652 +0.0114021722 +0.0616736951 +0.110528772 +0.156706011 +0.198989945 +0.236364171 +0.267913066 +0.292823571 +0.310504741 +0.320542339 +0.322706226 +0.31696167 +0.303467885 +0.282571781 +0.254797203 +0.220830017 +0.181496618 +0.137710222 +0.0905903659 +0.0412286437 +-0.00922717194 +-0.0596266885 +-0.108691843 +-0.155394572 +-0.198614114 +-0.237357505 +-0.27079341 +-0.298118582 +-0.318768189 +-0.332272681 +-0.338345268 +-0.336868837 +-0.327892237 +-0.311637945 +-0.288459684 +-0.258886242 +-0.223601778 +-0.183370242 +-0.139073578 +-0.0916768494 +-0.0422065643 +0.00827206787 +0.0586784106 +0.107939703 +0.155013875 +0.198911397 +0.238715703 +0.27360177 +0.302852495 +0.325872564 +0.342199548 +0.35151402 +0.353620215 +0.348504192 +0.336284716 +0.317191445 +0.291680644 +0.260236008 +0.223485028 +0.182259336 +0.137226853 +0.0894998191 +0.0398091619 +-0.0106466165 +-0.061107174 +-0.110347395 +-0.157603508 +-0.201844769 +-0.242236377 +-0.278092242 +-0.308603389 +-0.333262144 +-0.35161854 +-0.363303953 +-0.368113653 +-0.365977696 +-0.356945769 +-0.341185286 +-0.319012103 +-0.290857201 +-0.257247925 +-0.218815416 +-0.176277164 +-0.130423067 +-0.0821003 +-0.0321972796 +0.0183729471 +0.0686895878 +0.117840941 +0.164940874 +0.209144649 +0.24968211 +0.285808479 +0.316876681 +0.342358548 +0.36181267 +0.374910675 +0.381416192 +0.381226584 +0.374369009 +0.360942286 +0.341226027 +0.315576038 +0.284364708 +0.24825925 +0.207812914 +0.163707483 +0.116814896 +0.0677407733 +0.0175841918 +-0.0330875511 +-0.0831248066 +-0.131984015 +-0.178554183 +-0.222301999 +-0.262326531 +-0.298054473 +-0.328896935 +-0.354287307 +-0.373890007 +-0.387337039 +-0.394429957 +-0.395069275 +-0.389239106 +-0.377059378 +-0.358734858 +-0.33454005 +-0.304904076 +-0.270323164 +-0.231345598 +-0.18860154 +-0.142768747 +-0.0945697262 +-0.0448354124 +0.00567757793 +0.0561678626 +0.10583729 +0.153903548 +0.19961241 +0.242249447 +0.281150999 +0.315714265 +0.345406346 +0.369772115 +0.388440805 +0.40113122 +0.407655517 +0.407921494 +0.401933387 +0.389791172 +0.371669247 +0.347871747 +0.318769292 +0.284806372 +0.24650278 +0.204430811 +0.159181201 +0.111549375 +0.0621966015 +0.0118528626 +-0.0388106991 +-0.0888626407 +-0.13765356 +-0.184540948 +-0.228709433 +-0.269533414 +-0.306519511 +-0.338999399 +-0.366555962 +-0.388844117 +-0.40544342 +-0.416204267 +-0.420931499 +-0.419582581 +-0.412172845 +-0.39883476 +-0.379727504 +-0.355193201 +-0.325507336 +-0.291190238 +-0.252651387 +-0.210500586 +-0.165333232 +-0.117721055 +-0.0684985398 +-0.0181154029 +0.0324541938 +0.0826571295 +0.131815891 +0.179094738 +0.223987212 +0.26582561 +0.303966208 +0.337967909 +0.367368735 +0.391687362 +0.410654043 +0.424021575 +0.431582757 +0.433248534 +0.429012218 +0.418932644 +0.403127589 +0.381859108 +0.355404876 +0.324126127 +0.28844814 +0.248850143 +0.205832506 +0.160054222 +0.112089825 +0.062581038 +0.0121883994 +-0.0384176237 +-0.0885655914 +-0.137592005 +-0.184850057 +-0.229718106 +-0.27160776 +-0.309971469 +-0.344309528 +-0.374176407 +-0.399186321 +-0.419017984 +-0.433418485 +-0.442206243 +-0.445273014 +-0.44258493 +-0.434182562 +-0.42018002 +-0.400763113 +-0.37618659 +-0.346738748 +-0.312846478 +-0.27493799 +-0.233495211 +-0.189048518 +-0.142164713 +-0.0933939837 +-0.0434025495 +0.00714378977 +0.0576438364 +0.107463787 +0.156065023 +0.202679757 +0.246789908 +0.287861992 +0.325467401 +0.358972931 +0.388054784 +0.412390066 +0.431633313 +0.445544151 +0.453992831 +0.456855565 +0.454111295 +0.445789473 +0.432000187 +0.412952282 +0.388779785 +0.359921463 +0.326636435 +0.289331048 +0.248575107 +0.204625949 +0.15833798 +0.109957243 +0.0603253726 +0.00984445924 +-0.0407431704 +-0.0909217918 +-0.140033254 +-0.187535117 +-0.232821021 +-0.275408658 +-0.314716781 +-0.35039113 +-0.381870008 +-0.408959826 +-0.431160359 +-0.448367642 +-0.460283098 +-0.466820653 +-0.467893778 +-0.463503773 +-0.453676362 +-0.438573353 +-0.418368458 +-0.393220396 +-0.363565738 +-0.329660975 +-0.291848919 +-0.25072853 +-0.206674835 +-0.160101094 +-0.111768216 +-0.062114642 +-0.0116117702 +0.0390061372 +0.0891846299 +0.138391375 +0.186170861 +0.231769049 +0.27477479 +0.314708796 +0.351166441 +0.383656929 +0.411828413 +0.435392289 +0.454086856 +0.467713444 +0.476099034 +0.479159228 +0.476873425 +0.469270442 +0.456438213 +0.438522621 +0.415696605 +0.388263257 +0.356515594 +0.320804354 +0.281526139 +0.239116044 +0.194042733 +0.146803169 +0.0979170601 +0.0479210721 +-0.00263710493 +-0.0532047898 +-0.103230366 +-0.152169299 +-0.19949749 +-0.244683275 +-0.287249872 +-0.326738365 +-0.362724106 +-0.394824026 +-0.422692438 +-0.446027953 +-0.46458622 +-0.478171611 +-0.486642267 +-0.489911421 +-0.487948119 +-0.48077734 +-0.46847952 +-0.451189477 +-0.429094775 +-0.402433524 +-0.371491664 +-0.336585526 +-0.298074121 +-0.256423164 +-0.212044163 +-0.165405912 +-0.116999805 +-0.0673346007 +-0.016898507 +0.033774326 +0.0840723641 +0.133526678 +0.181623565 +0.227864668 +0.271860799 +0.312970869 +0.350868082 +0.385164406 +0.415537949 +0.441643628 +0.463180447 +0.47997303 +0.491861245 +0.498703278 +0.50042967 +0.497046835 +0.488562836 +0.475091681 +0.456788456 +0.43380337 +0.406361702 +0.374837336 +0.33947595 +0.300573041 +0.258714697 +0.214185516 +0.167376551 +0.118985808 +0.0692898716 +0.0188359401 +-0.0317231841 +-0.0821474185 +-0.131681567 +-0.179913036 +-0.226511224 +-0.27071562 +-0.312384546 +-0.350899678 +-0.385958453 +-0.417265107 +-0.444367189 +-0.467204019 +-0.485335381 +-0.49875168 +-0.507227463 +-0.510729916 +-0.509208873 +-0.502688059 +-0.491229362 +-0.474960891 +-0.454019867 +-0.428651125 +-0.399058847 +-0.365582032 +-0.32850974 +-0.28822236 +-0.245132332 +-0.199586766 +-0.152171793 +-0.103115878 +-0.0532260003 +-0.00254482253 +0.0479532712 +0.0981847582 +0.147418015 +0.195265139 +0.241354527 +0.285018695 +0.326145347 +0.36405476 +0.39854332 +0.429306847 +0.455915858 +0.478275846 +0.496074185 +0.509165208 +0.517473055 +0.520860965 +0.519342698 +0.512895541 +0.501631978 +0.485652678 +0.465018642 +0.440074717 +0.4109984 +0.377959747 +0.341426677 +0.301710024 +0.2590951 +0.214006595 +0.166984338 +0.118381526 +0.0685247635 +0.0180931205 +-0.0325058133 +-0.0828360236 +-0.132557508 +-0.180967843 +-0.22772516 +-0.272414634 +-0.314692036 +-0.354061773 +-0.390165222 +-0.422713385 +-0.451409881 +-0.476036365 +-0.496269513 +-0.511978229 +-0.523027189 +-0.529317805 +-0.530791687 +-0.527426676 +-0.519268844 +-0.506395835 +-0.48892637 +-0.467020583 +-0.440878477 +-0.410684441 +-0.376809509 +-0.339519934 +-0.299151954 +-0.256070018 +-0.210662418 +-0.16333775 +-0.114521196 +-0.0646328005 +-0.0141178027 +0.0365120869 +0.0868442718 +0.136430062 +0.184828095 +0.23160825 +0.276355446 +0.318673292 +0.358187561 +0.394549451 +0.427438617 +0.456565926 +0.481675943 +0.502549095 +0.519003516 +0.530896559 +0.538125945 +0.540630558 +0.538390877 +0.531429036 +0.51980852 +0.503633503 +0.48304782 +0.458233612 +0.429409627 +0.396829218 +0.360778036 +0.32157146 +0.279551773 +0.235085113 +0.188558236 +0.140375102 +0.090953333 +0.0407205641 +-0.00988927853 +-0.0604397388 +-0.110495599 +-0.159626623 +-0.207445819 +-0.253491919 +-0.297367496 +-0.338717452 +-0.377189507 +-0.412456574 +-0.444219493 +-0.472209492 +-0.496190394 +-0.515978316 +-0.531367901 +-0.542241215 +-0.548519299 +-0.550151771 +-0.547127643 +-0.539475292 +-0.527230819 +-0.510539798 +-0.489539964 +-0.464407862 +-0.435357327 +-0.402619755 +-0.366418687 +-0.32719352 +-0.285209709 +-0.240819978 +-0.194378821 +-0.146191242 +-0.0968709488 +-0.0467213442 +0.00384015439 +0.0544805242 +0.104668148 +0.153945972 +0.201970102 +0.248399399 +0.292821559 +0.334751515 +0.373937553 +0.410112637 +0.44291703 +0.472025809 +0.4972687 +0.518490805 +0.535406563 +0.547927679 +0.555975282 +0.559463759 +0.558363725 +0.552709196 +0.54248941 +0.527870847 +0.508955177 +0.485803849 +0.458739738 +0.427965876 +0.393587585 +0.356068909 +0.315696229 +0.272588121 +0.227373174 +0.180346758 +0.131617902 +0.0820205943 +0.0316996656 +-0.0190441039 +-0.06945899 +-0.119474001 +-0.168530213 +-0.216142106 +-0.26226778 +-0.306100706 +-0.347584871 +-0.386341877 +-0.421912045 +-0.454299189 +-0.48292211 +-0.507783829 +-0.528599214 +-0.545191074 +-0.557505358 +-0.565348067 +-0.56873603 +-0.567605403 +-0.561974895 +-0.55189748 +-0.537459319 +-0.518738282 +-0.495974339 +-0.469190836 +-0.438837435 +-0.404831184 +-0.367843793 +-0.327707619 +-0.285230722 +-0.2402515 +-0.193611213 +-0.145193797 +-0.0958594112 +-0.0455094822 +0.00496745229 +0.0556892812 +0.105725269 +0.155250664 +0.203288425 +0.250074269 +0.29465243 +0.337201564 +0.376967047 +0.413966437 +0.447691247 +0.478008921 +0.504648499 +0.527368474 +0.54609242 +0.560544548 +0.570756596 +0.576532388 +0.577899494 +0.574825546 +0.567350797 +0.55549036 +0.539432886 +0.519152397 +0.494971699 +0.466980453 +0.435356067 +0.400521624 +0.362455072 +0.321741977 +0.278564827 +0.233108893 +0.186057828 +0.137437325 +0.0877747118 +0.037544779 +-0.0132031788 +-0.0637126968 +-0.113717468 +-0.163133511 +-0.211095876 +-0.257520149 +-0.302198322 +-0.34442963 +-0.384125145 +-0.421085036 +-0.454749471 +-0.485039991 +-0.511822896 +-0.534668586 +-0.553542854 +-0.568346827 +-0.578863962 +-0.585074585 +-0.586937982 +-0.584420248 +-0.577564993 +-0.566421058 +-0.551009876 +-0.531558393 +-0.508168899 +-0.480952287 +-0.450156804 +-0.416080926 +-0.378923175 +-0.338835978 +-0.296304597 +-0.251613343 +-0.205053167 +-0.156823294 +-0.1075232 +-0.0574480293 +-0.00692973892 +0.0437694977 +0.094124972 +0.14374847 +0.192343734 +0.239582762 +0.285181955 +0.328596154 +0.369636103 +0.408004186 +0.443461604 +0.475716082 +0.504466911 +0.529570117 +0.550844956 +0.568146897 +0.581349121 +0.590315086 +0.595018169 +0.595425718 +0.591536073 +0.58336233 +0.570967675 +0.554466321 +0.53396853 +0.50962283 +0.481605218 +0.450109447 +0.41530522 +0.37757211 +0.337119084 +0.294236431 +0.249231509 +0.202426527 +0.154156216 +0.104708474 +0.0545154476 +0.00394873704 +-0.0466663605 +-0.0969698006 +-0.146604124 +-0.195216994 +-0.242463683 +-0.288009511 +-0.331547177 +-0.372776201 +-0.411336984 +-0.447003655 +-0.47952517 +-0.508672955 +-0.534242486 +-0.556054686 +-0.573957143 +-0.587825137 +-0.597562469 +-0.603102091 +-0.604406519 +-0.601468048 +-0.594308757 +-0.582969558 +-0.567547664 +-0.548147823 +-0.52490688 +-0.497988637 +-0.467582398 +-0.433901609 +-0.397182319 +-0.357681496 +-0.315675197 +-0.271456613 +-0.225333995 +-0.177628487 +-0.128671867 +-0.0788042288 +-0.0283716034 +0.0222764482 +0.0727892637 +0.122817508 +0.172015589 +0.220044035 +0.266571831 +0.311278686 +0.353857221 +0.394015063 +0.43147683 +0.465985991 +0.497306595 +0.525224855 +0.549550569 +0.570118381 +0.586789457 +0.59945585 +0.608015209 +0.612422005 +0.612647796 +0.60869271 +0.60058539 +0.588382741 +0.572169491 +0.552057554 +0.528185219 +0.50071616 +0.469838267 +0.435762331 +0.398720565 +0.358938287 +0.316698868 +0.272334603 +0.226114623 +0.178351783 +0.129368968 +0.0794968973 +0.0290718795 +-0.0215664613 +-0.0720774771 +-0.122191479 +-0.171455252 +-0.219560398 +-0.266208758 +-0.311088406 +-0.353899638 +-0.394356949 +-0.432190914 +-0.467216439 +-0.499060652 +-0.527578718 +-0.552588206 +-0.57392412 +-0.591446099 +-0.605043455 +-0.614627237 +-0.620101973 +-0.621462005 +-0.618700162 +-0.611836557 +-0.600912624 +-0.585963761 +-0.567161333 +-0.544604796 +-0.518444654 +-0.488854947 +-0.455961978 +-0.420065542 +-0.381430211 +-0.34027325 +-0.296866023 +-0.251411952 +-0.204289622 +-0.155885164 +-0.106443849 +-0.0562894775 +-0.00561565411 +0.0450257073 +0.09534171 +0.145050856 +0.193870975 +0.241534523 +0.28749719 +0.331602106 +0.373563777 +0.413249824 +0.450113603 +0.484057949 +0.51487328 +0.542446996 +0.566418753 +0.586715086 +0.603223648 +0.615874342 +0.624486142 +0.629067315 +0.629591634 +0.626026915 +0.618428476 +0.606849513 +0.591319109 +0.571960095 +0.548959455 +0.522431132 +0.492385211 +0.459303605 +0.42327417 +0.38440674 +0.343082653 +0.299638166 +0.254205115 +0.207010001 +0.158655887 +0.109268479 +0.0589185707 +0.00843361156 +-0.0421192987 +-0.0926634718 +-0.142418147 +-0.191253792 +-0.239106335 +-0.28527948 +-0.329613501 +-0.372067476 +-0.412012947 +-0.449326689 +-0.483983795 +-0.515424452 +-0.543609059 +-0.568505318 +-0.589667146 +-0.607148457 +-0.620845331 +-0.630565957 +-0.636342795 +-0.638100267 +-0.635845074 +-0.629565379 +-0.619335049 +-0.605238551 +-0.587233389 +-0.565648016 +-0.540447614 +-0.511822359 +-0.48009826 +-0.44515702 +-0.407595149 +-0.36742314 +-0.324845801 +-0.280426633 +-0.233974125 +-0.186272068 +-0.137317644 +-0.0874122111 +-0.0371675307 +0.0136748607 +0.0641071793 +0.114354947 +0.163850529 +0.212271521 +0.2595873 +0.305038185 +0.348910527 +0.390378923 +0.429597261 +0.466110291 +0.499736745 +0.530367156 +0.557604586 +0.581571256 +0.601798653 +0.618451823 +0.631209596 +0.640139026 +0.645108311 +0.64612314 +0.643164126 +0.636264611 +0.625435849 +0.610812272 +0.592369074 +0.5703962 +0.544784006 +0.516011286 +0.483854182 +0.448991932 +0.411076643 +0.370973024 +0.328239903 +0.283863853 +0.237364816 +0.189797454 +0.140658051 +0.0910646879 +0.0404712787 +-0.00994769674 +-0.0607505318 +-0.110789639 +-0.160554275 +-0.209014206 +-0.256531233 +-0.302246389 +-0.346365582 +-0.38823577 +-0.42789453 +-0.46491051 +-0.499159934 +-0.530426818 +-0.558454746 +-0.583212719 +-0.604363187 +-0.622005098 +-0.635801775 +-0.645871131 +-0.652010029 +-0.654263853 +-0.652590783 +-0.647010905 +-0.637538314 +-0.624297679 +-0.607220981 +-0.586639024 +-0.562410285 +-0.534928499 +-0.504198559 +-0.47042204 +-0.433965729 +-0.394663665 +-0.353280322 +-0.309570982 +-0.264117711 +-0.217117682 +-0.168623145 +-0.119389562 +-0.069152111 +-0.0186850968 +0.0319203846 +0.0825239277 +0.132389024 +0.181747056 +0.229883822 +0.276644727 +0.322006086 +0.365217444 +0.406455351 +0.445278691 +0.481381935 +0.514873951 +0.545165406 +0.57229568 +0.596164117 +0.616418629 +0.633129408 +0.64612719 +0.655309317 +0.660688992 +0.662182618 +0.659817058 +0.653561093 +0.643511758 +0.629729421 +0.61215578 +0.591117084 +0.566633195 +0.538689277 +0.50776259 +0.473866538 +0.437017337 +0.397822449 +0.356301567 +0.312462406 +0.267046512 +0.220075448 +0.171538218 +0.122255455 +0.072265046 +0.0216063594 +-0.0290180352 +-0.0794308261 +-0.129563499 +-0.178923012 +-0.227145109 +-0.274146109 +-0.319698258 +-0.363235803 +-0.404705222 +-0.444048147 +-0.480680065 +-0.514547289 +-0.545545354 +-0.573434053 +-0.597958109 +-0.619074692 +-0.636728296 +-0.650665029 +-0.660883545 +-0.667341347 +-0.669983645 +-0.668786626 +-0.66378298 +-0.654972089 +-0.642405449 +-0.6262078 +-0.606448367 +-0.583160555 +-0.5565621 +-0.526842812 +-0.494127986 +-0.458489353 +-0.420273422 +-0.379728926 +-0.337023908 +-0.292290117 +-0.245889292 +-0.198184234 +-0.149345942 +-0.0995925562 +-0.0491532687 +0.00141414589 +0.0519885196 +0.102285522 +0.152195302 +0.201117957 +0.248888416 +0.295274254 +0.340054975 +0.383025619 +0.423716799 +0.462043136 +0.497790518 +0.530807721 +0.560865775 +0.587716657 +0.611287013 +0.631445825 +0.648098849 +0.661131026 +0.670435757 +0.676001446 +0.677797803 +0.675814644 +0.670032592 +0.660524204 +0.647336007 +0.630542033 +0.610236276 +0.586495766 +0.559458314 +0.529354251 +0.496303647 +0.460490266 +0.422113045 +0.381333547 +0.338391153 +0.29364243 +0.247256352 +0.199489597 +0.150606294 +0.100876561 +0.0504442526 +-0.000165098028 +-0.0507722607 +-0.101113471 +-0.150911517 +-0.199892358 +-0.247786628 +-0.294427656 +-0.339378464 +-0.382452958 +-0.423437647 +-0.462108 +-0.498252334 +-0.53167295 +-0.562187207 +-0.589682631 +-0.613888315 +-0.634735781 +-0.652114939 +-0.665931512 +-0.676110753 +-0.682597828 +-0.685358095 +-0.684377269 +-0.679644978 +-0.671206198 +-0.659106639 +-0.643412746 +-0.624210754 +-0.601605926 +-0.575721954 +-0.546700268 +-0.514699246 +-0.479893338 +-0.442456931 +-0.402569672 +-0.360536783 +-0.316538346 +-0.270813168 +-0.223609235 +-0.175182363 +-0.125794801 +-0.0757138084 +-0.0252102042 +0.0254431013 +0.0759725815 +0.126105571 +0.175571735 +0.224104525 +0.271494021 +0.317377967 +0.361564535 +0.403817034 +0.443908702 +0.481624557 +0.516762536 +0.549134564 +0.578567547 +0.604904285 +0.628004292 +0.647744535 +0.664020065 +0.676744564 +0.685850779 +0.691290863 +0.693036606 +0.691079561 +0.685431066 +0.67612216 +0.663203394 +0.646744532 +0.626834164 +0.603579206 +0.577104306 +0.547551163 +0.515077749 +0.479857451 +0.442078127 +0.401941091 +0.359660029 +0.315459847 +0.269575461 +0.222250547 +0.173736228 +0.124289742 +0.0741730665 +0.023651531 +-0.0270075956 +-0.0775365183 +-0.127668332 +-0.177138433 +-0.225685908 +-0.273054912 +-0.318996007 +-0.363267472 +-0.405636564 +-0.445880736 +-0.483788791 +-0.519161981 +-0.551815038 +-0.581577124 +-0.608292717 +-0.631822406 +-0.652043596 +-0.668851138 +-0.682157852 +-0.691894961 +-0.698012428 +-0.700479195 +-0.699283318 +-0.694432007 +-0.685951561 +-0.673887209 +-0.658298425 +-0.639253272 +-0.616884736 +-0.591295977 +-0.562621161 +-0.531010408 +-0.496629 +-0.459656494 +-0.420285772 +-0.37872202 +-0.33518165 +-0.289891157 +-0.243085933 +-0.195009036 +-0.145909918 +-0.0959938698 +-0.0455794107 +0.00504685879 +0.0556584889 +0.105993882 +0.155793078 +0.204799097 +0.252759259 +0.299426482 +0.344560545 +0.387929321 +0.429347144 +0.46856546 +0.505333872 +0.539510843 +0.570921465 +0.599405179 +0.62481658 +0.647026142 +0.665920859 +0.681407532 +0.69341917 +0.701846649 +0.706681654 +0.707900511 +0.705498043 +0.699487576 +0.68990084 +0.676787788 +0.660170049 +0.640199686 +0.616966409 +0.590582719 +0.56118389 +0.528920417 +0.493957228 +0.456426883 +0.416529352 +0.374574557 +0.330707887 +0.285152466 +0.238139784 +0.189908513 +0.140619718 +0.0906082103 +0.0402038081 +-0.0104147563 +-0.0609915591 +-0.111271107 +-0.161019303 +-0.210092196 +-0.25796292 +-0.304541502 +-0.349593643 +-0.392892927 +-0.434235838 +-0.473507935 +-0.510267304 +-0.544466412 +-0.575934283 +-0.604513784 +-0.630096695 +-0.652521829 +-0.67161623 +-0.687344983 +-0.699630393 +-0.708412032 +-0.713653127 +-0.715286861 +-0.713340502 +-0.707825627 +-0.698770866 +-0.68616951 +-0.67014864 +-0.650791348 +-0.628182974 +-0.60243707 +-0.573572264 +-0.541899429 +-0.507549563 +-0.4706666 +-0.431434434 +-0.3898524 +-0.346495904 +-0.301414177 +-0.254826789 +-0.206886763 +-0.157825581 +-0.108124337 +-0.0578775236 +-0.00733355771 +0.0434667805 +0.0938937269 +0.143825746 +0.193057123 +0.241459599 +0.288683496 +0.334362955 +0.378402311 +0.420634867 +0.460901884 +0.498737389 +0.534125269 +0.566909674 +0.597023753 +0.6240509 +0.648017563 +0.668815013 +0.686395915 +0.700506818 +0.711186054 +0.718385638 +0.722059129 +0.722163287 +0.718734051 +0.711770774 +0.701275576 +0.687380105 +0.670125494 +0.649519799 +0.625723021 +0.598926664 +0.569206389 +0.536522821 +0.501343265 +0.46374543 +0.423819834 +0.381678007 +0.337859642 +0.292392284 +0.245280722 +0.197080751 +0.148003862 +0.0981262893 +0.0475814128 +-0.00295431546 +-0.0534852776 +-0.104033403 +-0.153881568 +-0.202931759 +-0.251152319 +-0.298191816 +-0.343622838 +-0.387445847 +-0.429600623 +-0.469436436 +-0.507019423 +-0.542369909 +-0.574910102 +-0.604664362 +-0.631633046 +-0.655476186 +-0.676116369 +-0.693568983 +-0.707657062 +-0.71829585 +-0.725506441 +-0.729212184 +-0.729397279 +-0.726076455 +-0.719230887 +-0.708962985 +-0.695268006 +-0.678167235 +-0.657898341 +-0.634424778 +-0.607815764 +-0.578428043 +-0.546183474 +-0.511229531 +-0.473995731 +-0.434356654 +-0.392584346 +-0.349111616 +-0.303765427 +-0.256995357 +-0.209154994 +-0.160029426 +-0.110294184 +-0.0601404093 +-0.00932333959 +0.0412236007 +0.0915881797 +0.141843502 +0.191069637 +0.239542778 +0.286994093 +0.332840849 +0.377352899 +0.419976862 +0.46049251 +0.499134162 +0.53513032 +0.568664064 +0.599626691 +0.627564458 +0.6526784 +0.674644146 +0.693365986 +0.708946119 +0.721040922 +0.72977969 +0.735067599 +0.736870733 +0.735188828 +0.730042021 +0.721455145 +0.709409906 +0.694106725 +0.675409857 +0.653611834 +0.628737605 +0.600771045 +0.570172514 +0.536653354 +0.500775536 +0.462510682 +0.421924311 +0.379616822 +0.335155639 +0.289432136 +0.242196303 +0.193774941 +0.144664169 +0.0944421696 +0.0442232278 +-0.00654306773 +-0.0571147682 +-0.107424228 +-0.157424006 +-0.206364442 +-0.254812356 +-0.301637198 +-0.347343932 +-0.391311394 +-0.433450476 +-0.473715719 +-0.511531876 +-0.547316545 +-0.580216421 +-0.61066856 +-0.638129577 +-0.662697789 +-0.68418778 +-0.702452607 +-0.717539954 +-0.729199242 +-0.737572176 +-0.742449057 +-0.743915196 +-0.741926792 +-0.736491165 +-0.727647986 +-0.715441798 +-0.699883502 +-0.681159971 +-0.659153458 +-0.634282551 +-0.606217082 +-0.575644803 +-0.542091594 +-0.506335479 +-0.467962054 +-0.427655921 +-0.38517952 +-0.341061209 +-0.295270294 +-0.248150334 +-0.199890215 +-0.150636447 +-0.100794003 +-0.050315099 +0.000197157271 +0.0509689387 +0.101229161 +0.151355663 +0.200449053 +0.249004002 +0.296038997 +0.34212553 +0.386249509 +0.429017117 +0.469431363 +0.508091913 +0.54406558 +0.577908114 +0.608790964 +0.637194993 +0.662428681 +0.684875718 +0.704003449 +0.720086568 +0.732760967 +0.742192202 +0.748181261 +0.750796718 +0.749987736 +0.745750328 +0.73815177 +0.727151525 +0.712892788 +0.69534474 +0.674673828 +0.650913539 +0.624192694 +0.594669505 +0.562368866 +0.527637021 +0.490326433 +0.451034251 +0.409373358 +0.366250675 +0.320977462 +0.274745169 +0.22681602 +0.178230047 +0.128534503 +0.0784549999 +0.0279015813 +-0.0227779488 +-0.0732695914 +-0.123642432 +-0.173158723 +-0.222320701 +-0.270026062 +-0.316981409 +-0.362130582 +-0.405925489 +-0.447757991 +-0.487619666 +-0.525371199 +-0.560603867 +-0.593578752 +-0.623613506 +-0.651122034 +-0.67550958 +-0.696989673 +-0.715314023 +-0.73041987 +-0.742317814 +-0.750825281 +-0.756039096 +-0.757833983 +-0.756251748 +-0.751291496 +-0.742993021 +-0.731319375 +-0.716484866 +-0.698299915 +-0.677144684 +-0.652887417 +-0.625709039 +-0.595864388 +-0.56309876 +-0.528125351 +-0.490555715 +-0.450924544 +-0.409325871 +-0.365669375 +-0.320717374 +-0.273981261 +-0.226272929 +-0.177518752 +-0.127772132 +-0.0777911754 +-0.0270597951 +0.023501416 +0.074016934 +0.124417558 +0.173936737 +0.223056652 +0.270957178 +0.3176585 +0.363221421 +0.40685111 +0.448953628 +0.488975834 +0.526737207 +0.562496628 +0.595465969 +0.625954834 +0.65372778 +0.678492302 +0.700443583 +0.719201436 +0.734801404 +0.74726105 +0.75634611 +0.762153027 +0.764608069 +0.763710271 +0.759443632 +0.751858537 +0.741016691 +0.726800655 +0.70952699 +0.68911957 +0.665580615 +0.639289622 +0.610090856 +0.578189388 +0.543915612 +0.50705399 +0.468066375 +0.427155798 +0.384068564 +0.339536663 +0.293593284 +0.245968295 +0.197639483 +0.148430614 +0.0982007267 +0.0479293325 +-0.00262643972 +-0.0534764478 +-0.103742339 +-0.153657844 +-0.203156463 +-0.251456264 +-0.298771337 +-0.345003891 +-0.389456316 +-0.43231666 +-0.473497168 +-0.512373297 +-0.54910476 +-0.58364269 +-0.615432855 +-0.6446081 +-0.671167603 +-0.694639527 +-0.715135479 +-0.732682805 +-0.74692987 +-0.757976557 +-0.765808135 +-0.77028887 +-0.771461847 +-0.769303874 +-0.763825302 +-0.75508306 +-0.743056676 +-0.727803302 +-0.709487946 +-0.688102091 +-0.663629148 +-0.636452245 +-0.60655235 +-0.573822512 +-0.538808176 +-0.501517092 +-0.461910719 +-0.420332441 +-0.377090828 +-0.332179792 +-0.285598249 +-0.238073891 +-0.189526622 +-0.139896637 +-0.0898203122 +-0.0394516997 +0.0111858601 +0.061969376 +0.112223286 +0.162010808 +0.211369809 +0.259678211 +0.306796214 +0.352667625 +0.397263859 +0.439907334 +0.480695319 +0.51958627 +0.556255617 +0.590445722 +0.622144076 +0.651366815 +0.677688921 +0.7011164 +0.721595182 +0.739105636 +0.753371082 +0.764458231 +0.772329318 +0.77692967 +0.778216183 +0.776221098 +0.770930171 +0.762350501 +0.750578139 +0.73564215 +0.717540559 +0.696381972 +0.672350354 +0.645485754 +0.615803935 +0.58349487 +0.548826638 +0.51184589 +0.472605079 +0.431304944 +0.38833418 +0.343725682 +0.29759456 +0.250051188 +0.201664582 +0.152423634 +0.102530422 +0.0519006353 +0.00134232993 +-0.0492310931 +-0.0996085532 +-0.149781577 +-0.199219286 +-0.247742249 +-0.295239375 +-0.341585612 +-0.386617687 +-0.429850541 +-0.471297628 +-0.51078661 +-0.548306965 +-0.583417553 +-0.616054303 +-0.646130341 +-0.673542633 +-0.698230719 +-0.719888751 +-0.738554993 +-0.754152281 +-0.766638231 +-0.775921389 +-0.781943332 +-0.784717475 +-0.784232676 +-0.780469392 +-0.773446194 +-0.763220404 +-0.74982657 +-0.733320485 +-0.713697995 +-0.691119569 +-0.665711668 +-0.637541775 +-0.606726632 +-0.573300257 +-0.537485765 +-0.499522366 +-0.459486319 +-0.417543089 +-0.373806986 +-0.328406059 +-0.281798583 +-0.234019201 +-0.185264944 +-0.135736773 +-0.0854352622 +-0.0349373144 +0.0156775541 +0.0662370973 +0.116533344 +0.166417153 +0.215731681 +0.26399512 +0.311180984 +0.357095598 +0.401550574 +0.444448469 +0.485528525 +0.524518805 +0.561362025 +0.595907389 +0.628013571 +0.657602173 +0.684491731 +0.708510514 +0.729629446 +0.747762453 +0.7628357 +0.77479551 +0.783591079 +0.789142451 +0.791466313 +0.790553577 +0.786408368 +0.779047989 +0.768465592 +0.754742462 +0.737948151 +0.718138487 +0.695394606 +0.66980956 +0.641487926 +0.610436972 +0.57696662 +0.541156309 +0.503135522 +0.463059212 +0.421090618 +0.377400602 +0.332054549 +0.285400424 +0.237631665 +0.188888867 +0.139370025 +0.0892761978 +0.0388106923 +-0.0118333332 +-0.062586308 +-0.112932686 +-0.162829659 +-0.212075165 +-0.260469865 +-0.307817944 +-0.353927902 +-0.398613324 +-0.4418204 +-0.483113172 +-0.522454054 +-0.559689025 +-0.594667944 +-0.627249842 +-0.657303478 +-0.68470787 +-0.709369445 +-0.731192427 +-0.750014744 +-0.765815052 +-0.778530094 +-0.78810906 +-0.79451379 +-0.797718912 +-0.797711939 +-0.794493309 +-0.788055948 +-0.77844689 +-0.765708939 +-0.749890083 +-0.731054303 +-0.709277667 +-0.684648011 +-0.657264586 +-0.627237641 +-0.594687986 +-0.559716884 +-0.522457087 +-0.483153969 +-0.441907796 +-0.39888405 +-0.354255256 +-0.308200284 +-0.260903636 +-0.212554698 +-0.16334698 +-0.113477344 +-0.0631452112 +-0.0125005624 +0.0382067944 +0.0887134033 +0.138874074 +0.188488683 +0.237359376 +0.285291347 +0.332093623 +0.377579813 +0.421568853 +0.46388572 +0.504362127 +0.542837185 +0.579158039 +0.613208172 +0.644817609 +0.673837949 +0.700184204 +0.72375208 +0.744448367 +0.762191297 +0.776910861 +0.788549081 +0.797060225 +0.802410985 +0.804580599 +0.80356092 +0.799356445 +0.791984282 +0.781474076 +0.767867883 +0.751219992 +0.73157954 +0.709042055 +0.683707534 +0.655666257 +0.625029432 +0.591918467 +0.556464486 +0.518807802 +0.479097357 +0.437490129 +0.394150504 +0.349249625 +0.30296471 +0.255478351 +0.206977789 +0.157654174 +0.107701811 +0.0573173878 +0.00669920501 +-0.043953609 +-0.0944418802 +-0.144567173 +-0.194132567 +-0.242943435 +-0.290808198 +-0.337539084 +-0.382952853 +-0.42687152 +-0.469123046 +-0.509542008 +-0.547970244 +-0.58426214 +-0.618275613 +-0.649861284 +-0.678908037 +-0.705302597 +-0.728942117 +-0.749734575 +-0.76759912 +-0.782466386 +-0.79427875 +-0.802990547 +-0.808568243 +-0.810990555 +-0.810248521 +-0.806345531 +-0.799297299 +-0.789131797 +-0.775889131 +-0.759621381 +-0.740392383 +-0.718277475 +-0.693363194 +-0.665746928 +-0.635536532 +-0.602849899 +-0.567814491 +-0.530566842 +-0.491252012 +-0.450023025 +-0.407040264 +-0.362470841 +-0.316487949 +-0.269270178 +-0.221000824 +-0.171867172 +-0.122059767 +-0.0717567025 +-0.0211724425 +0.0294926834 +0.0800513968 +0.130308072 +0.180068344 +0.229139865 +0.277333041 +0.324461764 +0.37034413 +0.414803137 +0.457667364 +0.49877163 +0.537957625 +0.575074515 +0.60997952 +0.642538452 +0.672626235 +0.700127368 +0.724936373 +0.746958183 +0.766108508 +0.782314143 +0.795513249 +0.805655571 +0.812702632 +0.816627863 +0.817416701 +0.815066633 +0.809587193 +0.800999922 +0.789338269 +0.774627071 +0.756953328 +0.73637784 +0.712977604 +0.686842737 +0.658073785 +0.626781324 +0.59308553 +0.557115714 +0.519009817 +0.478913875 +0.436981457 +0.393373071 +0.348255543 +0.301801379 +0.254188099 +0.205597556 +0.15621524 +0.106181931 +0.0557392842 +0.00511898755 +-0.0455280125 +-0.096008834 +-0.146131325 +-0.195704796 +-0.244540741 +-0.292453554 +-0.339261233 +-0.384786067 +-0.428855306 +-0.471301817 +-0.511964709 +-0.550698407 +-0.587405258 +-0.621813731 +-0.653868135 +-0.683447376 +-0.710439801 +-0.734743612 +-0.75626724 +-0.77492969 +-0.79066083 +-0.803401652 +-0.813104484 +-0.819733159 +-0.8232639 +-0.823668196 +-0.820958096 +-0.815146059 +-0.806254594 +-0.794317819 +-0.779381315 +-0.761501947 +-0.740747642 +-0.717197122 +-0.690939595 +-0.661995423 +-0.630609615 +-0.596852339 +-0.560843372 +-0.522718581 +-0.482621719 +-0.440703869 +-0.397122875 +-0.352042746 +-0.305633027 +-0.257921562 +-0.209372812 +-0.160032786 +-0.110085482 +-0.0597182835 +-0.00912004622 +0.0415196085 +0.0920110036 +0.142165116 +0.191929174 +0.240869092 +0.288887761 +0.335831698 +0.381525619 +0.425798999 +0.468486708 +0.509429618 +0.5485133 +0.585597988 +0.62040454 +0.652899659 +0.682962635 +0.710481878 +0.735355328 +0.757490826 +0.776821378 +0.793277892 +0.806727665 +0.817175237 +0.824582342 +0.828922026 +0.830178737 +0.828348373 +0.823418986 +0.815415939 +0.804389648 +0.790374252 +0.773422313 +0.753597242 +0.73097305 +0.705595127 +0.677545037 +0.647048085 +0.614149263 +0.578970778 +0.541643194 +0.502304938 +0.461032929 +0.417992041 +0.373509882 +0.327640898 +0.280554696 +0.232425275 +0.183430383 +0.133598091 +0.0833422108 +0.0328430621 +-0.0177837096 +-0.0683516205 +-0.118674506 +-0.168619785 +-0.218070494 +-0.266546431 +-0.314046778 +-0.360397136 +-0.405427422 +-0.448972486 +-0.491064319 +-0.53114873 +-0.569284871 +-0.605334029 +-0.639164424 +-0.67065247 +-0.699808497 +-0.726255612 +-0.750035268 +-0.771067116 +-0.789274736 +-0.804598084 +-0.817009508 +-0.826358746 +-0.8326831 +-0.835960087 +-0.836178343 +-0.833325265 +-0.827394574 +-0.818447 +-0.806506965 +-0.791618617 +-0.773836801 +-0.753119486 +-0.729709267 +-0.70365058 +-0.675021707 +-0.64392734 +-0.610395237 +-0.574588763 +-0.536789567 +-0.497030639 +-0.45545681 +-0.412181887 +-0.367211568 +-0.321109247 +-0.273833717 +-0.225556671 +-0.176453322 +-0.126414665 +-0.0761848076 +-0.0256781555 +0.0249280705 +0.0754507033 +0.125981138 +0.175805762 +0.224976017 +0.273337159 +0.320714627 +0.367202597 +0.412094926 +0.455492589 +0.497247676 +0.537236801 +0.575457173 +0.611381793 +0.645101314 +0.676494749 +0.705507812 +0.732005934 +0.755745632 +0.776761506 +0.79497856 +0.810385299 +0.822813468 +0.832245389 +0.83868057 +0.8420967 +0.842461632 +0.839773346 +0.834063543 +0.825353339 +0.813620196 +0.798939585 +0.781421601 +0.76109469 +0.738013834 +0.712121162 +0.683810251 +0.653042985 +0.619929841 +0.58440039 +0.546863067 +0.507429127 +0.466172899 +0.423111756 +0.378461106 +0.332627965 +0.285599539 +0.237485228 +0.188274764 +0.138672275 +0.0885686808 +0.0381423393 +-0.0127872161 +-0.0633262443 +-0.113637118 +-0.16354897 +-0.213188701 +-0.261815389 +-0.30945919 +-0.356006442 +-0.40154592 +-0.445463482 +-0.487723459 +-0.528253306 +-0.56711835 +-0.603805172 +-0.638276559 +-0.670484058 +-0.700477707 +-0.727835259 +-0.752561232 +-0.774619414 +-0.794041872 +-0.810516997 +-0.824098563 +-0.834760809 +-0.842502065 +-0.84717639 +-0.848850112 +-0.847513829 +-0.843124727 +-0.835760685 +-0.825440006 +-0.812151839 +-0.795922553 +-0.776947091 +-0.755225118 +-0.730695829 +-0.703601021 +-0.674096369 +-0.642210166 +-0.607777701 +-0.571413189 +-0.533054715 +-0.492724772 +-0.450459495 +-0.406856254 +-0.361815984 +-0.315244825 +-0.267642422 +-0.219241508 +-0.170049386 +-0.119850178 +-0.069631972 +-0.0191637454 +0.0315882754 +0.0822525115 +0.132405225 +0.18209941 +0.23156808 +0.279828539 +0.327096228 +0.373411846 +0.418429374 +0.461771073 +0.503508463 +0.54381642 +0.581859215 +0.617871624 +0.65189877 +0.683563224 +0.712719278 +0.739434708 +0.763672195 +0.785052406 +0.803696144 +0.819638931 +0.832594184 +0.842625632 +0.849741387 +0.853853712 +0.854960424 +0.853081837 +0.848171457 +0.840323124 +0.829551525 +0.815748197 +0.799187124 +0.779857464 +0.757656939 +0.732859929 +0.705585567 +0.675720692 +0.643440279 +0.609083752 +0.572519173 +0.53375049 +0.493395828 +0.451297299 +0.40724626 +0.362164422 +0.315824601 +0.267944542 +0.219515377 +0.170360077 +0.120212458 +0.0699273407 +0.0194991035 +-0.031351511 +-0.0819093421 +-0.132030281 +-0.18200278 +-0.231239942 +-0.279485207 +-0.327029778 +-0.373394249 +-0.418256344 +-0.461901173 +-0.503932392 +-0.544011667 +-0.582407117 +-0.618783037 +-0.652831128 +-0.684790132 +-0.714369663 +-0.741328086 +-0.765861569 +-0.787721044 +-0.806753731 +-0.823100068 +-0.836562518 +-0.847081338 +-0.854728988 +-0.859385315 +-0.861067782 +-0.859770476 +-0.855491831 +-0.848290507 +-0.838074554 +-0.825015559 +-0.809158882 +-0.790322403 +-0.768915144 +-0.744888104 +-0.718015397 +-0.688942849 +-0.65744603 +-0.62344086 +-0.587588513 +-0.549570525 +-0.509519828 +-0.468000825 +-0.424611079 +-0.379787411 +-0.333888453 +-0.286443159 +-0.238262971 +-0.189404152 +-0.13934734 +-0.0893248489 +-0.0389031553 +0.0120114511 +0.0624256027 +0.112887946 +0.163032586 +0.21230645 +0.261257132 +0.309082284 +0.355699652 +0.401624318 +0.445664499 +0.48832629 +0.529527638 +0.568580606 +0.605957909 +0.641180415 +0.674057833 +0.704965341 +0.733167564 +0.758931035 +0.782237835 +0.80267431 +0.820511951 +0.83549634 +0.847579303 +0.856878959 +0.863153671 +0.866519417 +0.866919814 +0.864375198 +0.858847892 +0.850412468 +0.83911543 +0.824823627 +0.807880247 +0.788073427 +0.765583965 +0.740635989 +0.712840322 +0.682932632 +0.650572378 +0.615901099 +0.579403894 +0.540528404 +0.500149972 +0.457991653 +0.414064193 +0.369111148 +0.322443101 +0.275012671 +0.226610079 +0.177149947 +0.127540421 +0.0769997267 +0.0265413019 +-0.0240466967 +-0.0748434725 +-0.124926915 +-0.175109454 +-0.224317991 +-0.272859602 +-0.320690438 +-0.367035326 +-0.412663081 +-0.456462373 +-0.498897357 +-0.539726948 +-0.578444844 +-0.615696387 +-0.650405836 +-0.683175099 +-0.713583894 +-0.741482323 +-0.767127453 +-0.789908413 +-0.810242854 +-0.827719402 +-0.842435207 +-0.854360744 +-0.863325432 +-0.86947144 +-0.872623114 +-0.872862361 +-0.870153325 +-0.864542607 +-0.855952566 +-0.844593713 +-0.830246973 +-0.813240632 +-0.793429693 +-0.770931462 +-0.745972514 +-0.718238306 +-0.688428173 +-0.655956555 +-0.621559536 +-0.584934335 +-0.546322379 +-0.506067856 +-0.463729202 +-0.420327859 +-0.374975084 +-0.328825492 +-0.281287688 +-0.232890861 +-0.183817238 +-0.133810966 +-0.0838633122 +-0.0329158725 +0.0174333803 +0.0682498283 +0.118520333 +0.168533616 +0.218045247 +0.266599167 +0.314677766 +0.361170954 +0.407096739 +0.451077366 +0.493981656 +0.534979815 +0.574316622 +0.611760164 +0.647034148 +0.680396154 +0.71116863 +0.739974912 +0.765929909 +0.789644148 +0.81051284 +0.828824154 +0.844311733 +0.857011481 +0.86687986 +0.873833863 +0.877920228 +0.879069976 +0.877289341 +0.872638852 +0.86501228 +0.854610666 +0.841272301 +0.825229692 +0.806384162 +0.784889164 +0.760811499 +0.734127365 +0.705159044 +0.673620303 +0.640164483 +0.604172569 +0.566677051 +0.526718036 +0.485607175 +0.44234635 +0.39809249 +0.352110223 +0.305292385 +0.257201718 +0.208435181 +0.158873832 +0.108801804 +0.0584239086 +0.00770880153 +-0.0428235115 +-0.0935090822 +-0.143534172 +-0.193516542 +-0.242381686 +-0.290995321 +-0.338064994 +-0.384661559 +-0.429325616 +-0.473282506 +-0.515004971 +-0.555651879 +-0.593925799 +-0.630739395 +-0.665052056 +-0.697559719 +-0.727451024 +-0.755236692 +-0.780305433 +-0.803014724 +-0.822924041 +-0.840268578 +-0.854750538 +-0.866511441 +-0.875370664 +-0.881401157 +-0.884517449 +-0.884744566 +-0.882074515 +-0.876499874 +-0.868077397 +-0.856777044 +-0.842712869 +-0.825836193 +-0.806316297 +-0.784084036 +-0.759367047 +-0.73206841 +-0.702482028 +-0.670470964 +-0.636407435 +-0.60009811 +-0.562008837 +-0.521870361 +-0.480259707 +-0.436810194 +-0.392228582 +-0.346028595 +-0.299064993 +-0.250710479 +-0.201984381 +-0.152099165 +-0.102252172 +-0.0514801049 +-0.00116723533 +0.0498358966 +0.09995506 +0.15052978 +0.199836175 +0.249255202 +0.297161089 +0.344745966 +0.390646988 +0.435780817 +0.479079413 +0.521179739 +0.561310328 +0.599836825 +0.636272958 +0.67073452 +0.702995553 +0.732956677 +0.760613892 +0.785700284 +0.808382376 +0.828285698 +0.845683568 +0.860165262 +0.872036049 +0.880935253 +0.887095462 +0.890316647 +0.890683062 +0.888176138 +0.88277026 +0.874543587 +0.863462889 +0.849597447 +0.833013652 +0.813662297 +0.79181866 +0.767204485 +0.740412116 +0.710825948 +0.679391133 +0.645324413 +0.609566208 +0.571524611 +0.531859371 +0.490358767 +0.447274127 +0.402872511 +0.356901982 +0.310191742 +0.261908284 +0.21343313 +0.163592064 +0.11382313 +0.0632358243 +0.0127232077 +-0.0379520305 +-0.0885659084 +-0.138674516 +-0.188741901 +-0.237641751 +-0.286517601 +-0.333756697 +-0.380468263 +-0.425608798 +-0.46957016 +-0.512019489 +-0.552686148 +-0.591881077 +-0.628764088 +-0.66416275 +-0.696942497 +-0.727831653 +-0.7562034 +-0.782224007 +-0.805789369 +-0.82664928 +-0.845067341 +-0.860572825 +-0.873508318 +-0.88352901 +-0.890787457 +-0.895187028 +-0.896727994 +-0.895400078 +-0.891249778 +-0.884176065 +-0.874375665 +-0.861711131 +-0.846327882 +-0.828290129 +-0.807466711 +-0.784309406 +-0.758321826 +-0.730232681 +-0.699619875 +-0.666828904 +-0.632031156 +-0.59490804 +-0.556321038 +-0.515482157 +-0.473395641 +-0.429619538 +-0.384421325 +-0.338299887 +-0.290531499 +-0.242460674 +-0.193140726 +-0.143460822 +-0.0933418903 +-0.042612579 +0.00774644607 +0.0587128583 +0.108964219 +0.159112202 +0.208822433 +0.257523207 +0.306054139 +0.352969243 +0.399163212 +0.443978879 +0.487239838 +0.529380276 +0.569361111 +0.60792747 +0.644371173 +0.678751677 +0.711236541 +0.741144949 +0.769018108 +0.794271839 +0.817041096 +0.837360748 +0.854853046 +0.869823662 +0.881938918 +0.891296593 +0.897883413 +0.901592331 +0.902484808 +0.900526498 +0.895746488 +0.888090086 +0.877729628 +0.864494428 +0.848608488 +0.830094256 +0.808777349 +0.785162698 +0.758876206 +0.730276432 +0.699523778 +0.66617652 +0.631157779 +0.593930246 +0.554805692 +0.514218485 +0.471511105 +0.427768364 +0.382568085 +0.335918093 +0.288643339 +0.240015641 +0.19088251 +0.141291356 +0.0907004369 +0.0404259647 +-0.010283838 +-0.0610252612 +-0.111222991 +-0.161616472 +-0.211092835 +-0.2599125 +-0.308338902 +-0.355290703 +-0.401450613 +-0.446344687 +-0.489575464 +-0.531741283 +-0.571885238 +-0.610257732 +-0.647055038 +-0.681445784 +-0.713921862 +-0.744197612 +-0.771962026 +-0.797577606 +-0.820542228 +-0.84091257 +-0.858879822 +-0.873958275 +-0.886389371 +-0.896104512 +-0.902957984 +-0.907047828 +-0.908298308 +-0.906737077 +-0.90232036 +-0.89512695 +-0.885191295 +-0.872355061 +-0.856964464 +-0.838878565 +-0.818049964 +-0.794881693 +-0.769114695 +-0.740914356 +-0.710615431 +-0.6778575 +-0.643103572 +-0.606519054 +-0.567662116 +-0.527346877 +-0.485496086 +-0.44160864 +-0.396870661 +-0.350837937 +-0.303295986 +-0.255307955 +-0.206365437 +-0.156507106 +-0.106596837 +-0.0561084163 +-0.00531676331 +0.04512944 +0.0957533578 +0.146075454 +0.195657501 +0.245000453 +0.293468025 +0.340810894 +0.387490994 +0.432774041 +0.476565861 +0.519275426 +0.560134323 +0.599162636 +0.636705635 +0.672023998 +0.705209201 +0.736535441 +0.765349596 +0.79177463 +0.816009679 +0.837533998 +0.856469493 +0.87293947 +0.886586923 +0.897511103 +0.905761631 +0.911159057 +0.913771865 +0.91358064 +0.910578347 +0.904809425 +0.896192051 +0.884867532 +0.870877846 +0.854086797 +0.834742466 +0.812919544 +0.788436294 +0.761591334 +0.73253827 +0.70105886 +0.667435385 +0.631953929 +0.594368408 +0.554872324 +0.513940531 +0.471306901 +0.427003958 +0.381749036 +0.335262487 +0.287350133 +0.239017237 +0.18995489 +0.139772081 +0.0896692291 +0.0393096858 +-0.0116111218 +-0.0621927868 +-0.112466555 +-0.162719175 +-0.212401337 +-0.261209839 +-0.309414542 +-0.356838058 +-0.402843114 +-0.447685495 +-0.491546486 +-0.533487841 +-0.573824734 +-0.612770984 +-0.6495699 +-0.68434519 +-0.717244114 +-0.747916912 +-0.776180059 +-0.802169927 +-0.825844374 +-0.846823748 +-0.865255335 +-0.881214443 +-0.894351985 +-0.904785217 +-0.912527296 +-0.917473453 +-0.919625171 +-0.919003855 +-0.915564034 +-0.90937739 +-0.900456191 +-0.888706285 +-0.874328469 +-0.857345517 +-0.837693842 +-0.815440518 +-0.790860678 +-0.763903286 +-0.734336946 +-0.70281862 +-0.669200662 +-0.633378182 +-0.595621114 +-0.556259401 +-0.5152196 +-0.472188529 +-0.428155371 +-0.38283386 +-0.336115699 +-0.288373494 +-0.239998313 +-0.190898325 +-0.140728039 +-0.090598745 +-0.0402079447 +0.0105183681 +0.0613097929 +0.111623001 +0.161608595 +0.211521462 +0.260478503 +0.308575999 +0.355855655 +0.402327015 +0.447232846 +0.490808214 +0.533154259 +0.573828603 +0.612618237 +0.649584184 +0.684911761 +0.717897303 +0.748714393 +0.777357879 +0.803804964 +0.827640997 +0.849012737 +0.867934856 +0.884238733 +0.897818337 +0.90872523 +0.91696672 +0.922409276 +0.925086303 +0.92501008 +0.922130729 +0.916506601 +0.908156357 +0.897084324 +0.883224779 +0.866827785 +0.847852047 +0.826284836 +0.802144308 +0.775758755 +0.747065659 +0.71601716 +0.682769965 +0.647656481 +0.610616327 +0.571562841 +0.530803959 +0.48863756 +0.44501671 +0.399824136 +0.353493962 +0.306283568 +0.258159671 +0.208991399 +0.159285232 +0.109277515 +0.0589401359 +0.00815033461 +-0.0425832592 +-0.0930110815 +-0.143169639 +-0.193151943 +-0.242519298 +-0.290972591 +-0.338571065 +-0.385361253 +-0.43103347 +-0.475213846 +-0.517994974 +-0.559369453 +-0.599189059 +-0.637003181 +-0.672940485 +-0.706944826 +-0.739024512 +-0.768682891 +-0.79607625 +-0.821124177 +-0.843923823 +-0.864029696 +-0.881585216 +-0.896543663 +-0.90892214 +-0.918546319 +-0.92543678 +-0.929601579 +-0.931023735 +-0.929670656 +-0.92557374 +-0.918751488 +-0.909211924 +-0.896892951 +-0.882005521 +-0.864521755 +-0.844493052 +-0.821823976 +-0.796803613 +-0.769486484 +-0.739904545 +-0.708054187 +-0.673999788 +-0.638140078 +-0.600402156 +-0.560896583 +-0.519440952 +-0.476681715 +-0.432567627 +-0.387179114 +-0.34051888 +-0.292720197 +-0.24430785 +-0.195173771 +-0.145461597 +-0.0950056526 +-0.0444804767 +0.00608806404 +0.0566445736 +0.107101007 +0.15752405 +0.207151113 +0.256177188 +0.304459248 +0.352029415 +0.398580736 +0.443776057 +0.487678527 +0.530160218 +0.57132442 +0.610651627 +0.648117558 +0.683693951 +0.71727727 +0.748985166 +0.778271723 +0.805278692 +0.8299379 +0.852194043 +0.872062393 +0.889238714 +0.903822854 +0.915772552 +0.925063011 +0.931663704 +0.935494154 +0.936598557 +0.93497387 +0.930613249 +0.92348899 +0.913700085 +0.901249626 +0.88617393 +0.868489941 +0.84816209 +0.825470476 +0.800375047 +0.772948763 +0.743254809 +0.711183991 +0.677242157 +0.641328373 +0.60354687 +0.564007261 +0.522554617 +0.479796186 +0.435672808 +0.390279661 +0.343748271 +0.295999581 +0.247465868 +0.198332986 +0.148619493 +0.0984692627 +0.0479249373 +-0.00290981492 +-0.053493793 +-0.103928086 +-0.154066905 +-0.203765342 +-0.253168067 +-0.301587024 +-0.349095311 +-0.395598201 +-0.440961458 +-0.485159956 +-0.528022124 +-0.569173889 +-0.608683842 +-0.646438087 +-0.682327807 +-0.716412921 +-0.748291751 +-0.777960876 +-0.805385651 +-0.830487169 +-0.8532045 +-0.873552985 +-0.89124661 +-0.906369613 +-0.918878617 +-0.928737765 +-0.935927411 +-0.940408157 +-0.942145503 +-0.941166655 +-0.937474611 +-0.931080161 +-0.921971755 +-0.910169668 +-0.895778859 +-0.878806694 +-0.859302127 +-0.837321365 +-0.812860293 +-0.786007046 +-0.756979415 +-0.725771059 +-0.692471728 +-0.657177148 +-0.619919529 +-0.580763951 +-0.540095941 +-0.497871694 +-0.454212424 +-0.409243426 +-0.363078291 +-0.315608686 +-0.267489476 +-0.21859758 +-0.169073136 +-0.119058061 +-0.0686956425 +-0.017926308 +0.0327882416 +0.0833214599 +0.133621021 +0.183542997 +0.232944571 +0.281735267 +0.329891472 +0.376879317 +0.422792597 +0.467500134 +0.510874222 +0.552790988 +0.593246877 +0.631979667 +0.66880315 +0.703717532 +0.736623256 +0.767426516 +0.796039518 +0.822476936 +0.846484285 +0.868036604 +0.887111617 +0.9036551 +0.917620051 +0.928966821 +0.937687823 +0.943692341 +0.946993552 +0.947593512 +0.945490708 +0.940691312 +0.933209163 +0.923025324 +0.910202352 +0.894805381 +0.876857425 +0.856409732 +0.833520638 +0.808255402 +0.780646327 +0.750726086 +0.718770598 +0.684766686 +0.648811127 +0.61100621 +0.57145945 +0.530283275 +0.487440295 +0.443286925 +0.397931589 +0.351441055 +0.303947326 +0.255585218 +0.206491974 +0.156806879 +0.106446239 +0.0559827411 +0.00537346224 +-0.0452561266 +-0.0957625594 +-0.146002753 +-0.195834411 +-0.245116425 +-0.293908839 +-0.341689252 +-0.388482311 +-0.434179421 +-0.478651357 +-0.521772389 +-0.563420632 +-0.603478393 +-0.641930223 +-0.678525773 +-0.713134187 +-0.745728581 +-0.776217007 +-0.804513484 +-0.830538239 +-0.854217926 +-0.875485833 +-0.894352163 +-0.910602786 +-0.924281586 +-0.93535128 +-0.943780837 +-0.949546675 +-0.952632723 +-0.953030465 +-0.95073803 +-0.945732514 +-0.938068415 +-0.927758071 +-0.91483074 +-0.899323038 +-0.881278833 +-0.860749122 +-0.83779188 +-0.812471898 +-0.784773678 +-0.75490185 +-0.722932436 +-0.688924839 +-0.65297486 +-0.615183738 +-0.575657857 +-0.53450845 +-0.491851283 +-0.447806328 +-0.402323169 +-0.355866721 +-0.308409897 +-0.260081867 +-0.211018378 +-0.161357208 +-0.111237776 +-0.0608007539 +-0.0101876691 +0.0404594907 +0.0911341367 +0.141469073 +0.191362906 +0.240724795 +0.289416444 +0.337301472 +0.384245786 +0.430117962 +0.474789607 +0.518135722 +0.560035044 +0.600494009 +0.639150564 +0.676010619 +0.710981933 +0.743966844 +0.774873261 +0.803614929 +0.830111661 +0.854289561 +0.876081231 +0.895425951 +0.91229004 +0.926600605 +0.938292429 +0.947364187 +0.953790771 +0.957554457 +0.958644955 +0.957059432 +0.952802519 +0.945886294 +0.936330242 +0.924161205 +0.909406782 +0.89206718 +0.872278369 +0.850056276 +0.82546301 +0.798567264 +0.769444124 +0.738174858 +0.704846683 +0.669552525 +0.632390755 +0.593464914 +0.552883424 +0.510759284 +0.467110294 +0.422226004 +0.376188211 +0.329100156 +0.281092777 +0.23229953 +0.182856023 +0.132899633 +0.0825691265 +0.0320042732 +-0.0186545411 +-0.0692667055 +-0.119691773 +-0.169789852 +-0.219440846 +-0.268571723 +-0.316855593 +-0.36426523 +-0.410669295 +-0.455939266 +-0.499949797 +-0.542579062 +-0.583709091 +-0.623226096 +-0.661020782 +-0.696988651 +-0.731030284 +-0.763051621 +-0.792964212 +-0.820685462 +-0.846138858 +-0.869287108 +-0.890004156 +-0.908247453 +-0.923981433 +-0.937162829 +-0.947755437 +-0.955730215 +-0.961065356 +-0.963746346 +-0.963766003 +-0.961124495 +-0.955829329 +-0.947895335 +-0.937344621 +-0.924206503 +-0.908517429 +-0.890320868 +-0.869667194 +-0.846613539 +-0.821191342 +-0.793509694 +-0.763656884 +-0.731697347 +-0.697719289 +-0.66181645 +-0.624087843 +-0.584637482 +-0.543574092 +-0.501010805 +-0.457064854 +-0.41185724 +-0.365512407 +-0.318157889 +-0.269923966 +-0.2209433 +-0.17135057 +-0.121282104 +-0.0708755006 +-0.0202692507 +0.0303976409 +0.0809860391 +0.13135706 +0.181372453 +0.230963068 +0.279856144 +0.327983588 +0.375215767 +0.421423234 +0.466479385 +0.510260805 +0.552647606 +0.593523751 +0.632777376 +0.670301089 +0.705992265 +0.739753322 +0.771491991 +0.801121562 +0.82856112 +0.853735765 +0.876576812 +0.89702198 +0.915015554 +0.930508541 +0.943458795 +0.953831132 +0.961597424 +0.966736672 +0.969235058 +0.969085984 +0.966290082 +0.960855213 +0.952796441 +0.942135988 +0.928903171 +0.913134317 +0.894872666 +0.874168242 +0.851059124 +0.825640973 +0.797971272 +0.76812404 +0.736180809 +0.702228797 +0.666360675 +0.628674304 +0.589272472 +0.548262609 +0.505756496 +0.461869951 +0.416722523 +0.370437156 +0.323139857 +0.274959352 +0.226026732 +0.176475099 +0.126439203 +0.0760550717 +0.0254596429 +-0.0252096081 +-0.0758150428 +-0.126219233 +-0.176285334 +-0.225877457 +-0.274861034 +-0.323103188 +-0.370473088 +-0.416842304 +-0.462085158 +-0.506079056 +-0.548704829 +-0.589847046 +-0.629394329 +-0.667239652 +-0.703280631 +-0.737419797 +-0.769564857 +-0.799628947 +-0.827530857 +-0.853195254 +-0.876552882 +-0.897540745 +-0.916102276 +-0.932187486 +-0.9457531 +-0.956762664 +-0.965186648 +-0.971002517 +-0.974194791 +-0.974755084 +-0.972682124 +-0.967981749 +-0.960666895 +-0.95075755 +-0.938280704 +-0.923270267 +-0.905766978 +-0.885818292 +-0.863478247 +-0.838807315 +-0.811872237 +-0.782745843 +-0.751506846 +-0.718239633 +-0.683034035 +-0.645985076 +-0.607192724 +-0.566761611 +-0.524800756 +-0.481423262 +-0.436746019 +-0.390889378 +-0.343976833 +-0.296134683 +-0.247491694 +-0.198178746 +-0.14832849 +-0.098074979 +-0.0475533164 +0.00310071282 +0.0537510054 +0.104261506 +0.154496572 +0.204321338 +0.253602078 +0.302206564 +0.350004418 +0.39690079 +0.442706611 +0.487324528 +0.53063933 +0.572534996 +0.612899343 +0.651624325 +0.688606318 +0.723746399 +0.756950607 +0.788130192 +0.817201852 +0.844087952 +0.86871673 +0.891022484 +0.91094575 +0.928433453 +0.943439047 +0.955922639 +0.965851091 +0.973198103 +0.977944286 +0.980077203 +0.979591406 +0.976488441 +0.970776846 +0.962472123 +0.951596689 +0.938179822 +0.922257569 +0.903872656 +0.883074365 +0.859918402 +0.834466743 +0.806787469 +0.776940595 +0.744996844 +0.711095121 +0.675295552 +0.637693705 +0.59838992 +0.557489042 +0.515100137 +0.4713362 +0.426313854 +0.380153036 +0.332976679 +0.28491038 +0.236082067 +0.186621659 +0.136660716 +0.0863320913 +0.0357695776 +-0.0148924496 +-0.0655193889 +-0.115976771 +-0.166130613 +-0.21584778 +-0.26499633 +-0.313455848 +-0.361156979 +-0.407821871 +-0.4534085 +-0.497796066 +-0.540866981 +-0.582507184 +-0.622606438 +-0.661058622 +-0.697762012 +-0.732619541 +-0.765539064 +-0.796433591 +-0.825221519 +-0.851826845 +-0.876179362 +-0.898214846 +-0.917875219 +-0.935108701 +-0.949869945 +-0.962130788 +-0.971840469 +-0.978967016 +-0.983506106 +-0.985446016 +-0.984781892 +-0.981515759 +-0.975656509 +-0.967219881 +-0.956228407 +-0.942711359 +-0.926704659 +-0.908250788 +-0.887398668 +-0.864203529 +-0.838726764 +-0.811035759 +-0.781161429 +-0.749219025 +-0.715336344 +-0.679565753 +-0.642001677 +-0.602743234 +-0.561893974 +-0.519561602 +-0.475857692 +-0.430897396 +-0.384799134 +-0.337684285 +-0.289676863 +-0.240903195 +-0.191491582 +-0.141523583 +-0.0911307116 +-0.040588311 +0.0100646935 +0.0606952386 +0.11117036 +0.161357541 +0.211125061 +0.26034234 +0.308880278 +0.356611599 +0.403411175 +0.449156361 +0.493727309 +0.537069145 +0.579006366 +0.619358438 +0.658089931 +0.695099551 +0.730290544 +0.763570948 +0.794853825 +0.824057491 +0.851105728 +0.875927974 +0.89845951 +0.918641627 +0.936454134 +0.951791139 +0.964617872 +0.974922773 +0.982679187 +0.987867126 +0.99047331 +0.990491207 +0.987921038 +0.982769779 +0.975051137 +0.96478551 +0.951966688 +0.936659011 +0.918923071 +0.898787743 +0.876305796 +0.851536095 +0.824543448 +0.795398433 +0.764177209 +0.730961317 +0.695837465 +0.658858814 +0.620083386 +0.579791779 +0.537987171 +0.49477851 +0.450278362 +0.404602614 +0.357870172 +0.310202653 +0.261724063 +0.212560479 +0.162742219 +0.112489932 +0.0620415752 +0.0114282305 +-0.0392186586 +-0.0897676029 +-0.140087408 +-0.190047514 +-0.239518334 +-0.288371586 +-0.336521572 +-0.383911988 +-0.43015215 +-0.475279667 +-0.519177707 +-0.561732662 +-0.602834433 +-0.642376715 +-0.680257273 +-0.716378198 +-0.750695899 +-0.783100625 +-0.813383915 +-0.841562965 +-0.867565122 +-0.891323384 +-0.912776564 +-0.931869448 +-0.948552935 +-0.962784155 +-0.974562912 +-0.98376946 +-0.990426851 +-0.994524484 +-0.996052075 +-0.995005965 +-0.991389135 +-0.985211188 +-0.976488325 +-0.965195531 +-0.951420237 +-0.935201668 +-0.916568401 +-0.895568739 +-0.872257061 +-0.846693678 +-0.818944676 +-0.789081743 +-0.757033728 +-0.72314566 +-0.687406307 +-0.649893248 +-0.610703206 +-0.569937183 +-0.527700196 +-0.484101008 +-0.43917361 +-0.393031389 +-0.346021551 +-0.298118171 +-0.249444419 +-0.200125401 +-0.150287838 +-0.100059741 +-0.0495632317 +0.0013117643 +0.0519349714 +0.102428245 +0.152662081 +0.202507683 +0.25183729 +0.300524499 +0.348444595 +0.395703142 +0.441726928 +0.486605535 +0.530239325 +0.572516715 +0.613329623 +0.652573745 +0.690160596 +0.726142341 +0.760074779 +0.792062581 +0.822024184 +0.849883221 +0.875568717 +0.899015265 +0.920202418 +0.939044388 +0.955411813 +0.969336637 +0.980783599 +0.989723764 +0.996134594 +1 +1 + +shape_id 6 +num_samples 3976 +0.0330492484 +-0.00493015979 +-0.050536086 +-0.0760880432 +-0.0717444892 +-0.0414759329 +0.00403314474 +0.0525351165 +0.0933358376 +0.118848461 +0.125193298 +0.112005262 +0.081849765 +0.0393848197 +-0.00954712122 +-0.0587983537 +-0.102615997 +-0.136275045 +-0.156421065 +-0.161261746 +-0.150600923 +-0.125695181 +-0.0890294147 +-0.0439616678 +0.0055467508 +0.0553995581 +0.101639088 +0.140715967 +0.169795163 +0.186870564 +0.190849618 +0.181609893 +0.159922496 +0.127357223 +0.0861470618 +0.0390109005 +-0.0110693353 +-0.0609606441 +-0.107707168 +-0.148572354 +-0.181229953 +-0.203890985 +-0.215384097 +-0.215158163 +-0.203318557 +-0.180580464 +-0.148222108 +-0.107977861 +-0.0619393367 +-0.012460847 +0.0379875505 +0.0869560657 +0.132098529 +0.171304615 +0.202793108 +0.225125614 +0.237374357 +0.239029706 +0.230086738 +0.21099923 +0.18265449 +0.146309051 +0.103550079 +0.0562376464 +0.00628377457 +-0.0441668237 +-0.093106799 +-0.138580578 +-0.178792833 +-0.212182956 +-0.237481627 +-0.253753685 +-0.260426091 +-0.257283273 +-0.244502367 +-0.222566827 +-0.192370704 +-0.155026247 +-0.111903011 +-0.0645794569 +-0.0147664218 +0.0357833533 +0.085325414 +0.132107372 +0.174549223 +0.211236191 +0.240961305 +0.262715652 +0.275850923 +0.279935774 +0.27488966 +0.260890522 +0.238440926 +0.208284194 +0.171403216 +0.128984652 +0.0823769181 +0.033044807 +-0.017478483 +-0.067684537 +-0.115965665 +-0.160903742 +-0.201215508 +-0.235618408 +-0.263193491 +-0.283094244 +-0.294809519 +-0.297987479 +-0.292586768 +-0.27877398 +-0.256972219 +-0.227831655 +-0.192188447 +-0.151058905 +-0.105603723 +-0.0570934143 +-0.00687134963 +0.0436864764 +0.093242515 +0.14038585 +0.183893216 +0.222640514 +0.255585347 +0.281855859 +0.300834201 +0.311983556 +0.315076294 +0.310038428 +0.297023578 +0.276373862 +0.248662401 +0.214591789 +0.1750066 +0.130951877 +0.0835314064 +0.0339181632 +-0.0166590685 +-0.0669565145 +-0.115746222 +-0.161845969 +-0.204147544 +-0.241642718 +-0.273447998 +-0.298833326 +-0.317172198 +-0.3280752 +-0.331305945 +-0.326792616 +-0.314674856 +-0.295231837 +-0.268936554 +-0.23642399 +-0.198405694 +-0.155821757 +-0.109590394 +-0.0607850588 +-0.0105483202 +0.0401163038 +0.0899313596 +0.137862935 +0.182886755 +0.223986872 +0.260251175 +0.290926439 +0.315356717 +0.333024991 +0.343563083 +0.346758197 +0.342556013 +0.331060315 +0.312529233 +0.287368216 +0.256119969 +0.219451612 +0.17813938 +0.133051262 +0.0851279476 +0.035313253 +-0.0152903825 +-0.065659004 +-0.114793614 +-0.16174649 +-0.205445239 +-0.245115748 +-0.27995928 +-0.309224027 +-0.332438357 +-0.349045917 +-0.35880967 +-0.361506636 +-0.357105394 +-0.345723251 +-0.327558874 +-0.303008688 +-0.272570309 +-0.236753586 +-0.19637925 +-0.152175805 +-0.104947386 +-0.0556479621 +-0.00523618896 +0.0453641716 +0.0951998025 +0.14336 +0.18890244 +0.230984685 +0.268844426 +0.301786099 +0.329208353 +0.350614456 +0.365620646 +0.373962305 +0.375497867 +0.370210422 +0.358207011 +0.339715677 +0.315080333 +0.284735588 +0.249245079 +0.209268426 +0.165513045 +0.118760985 +0.0698105871 +0.0195416775 +-0.0310995931 +-0.081268562 +-0.130170353 +-0.176812318 +-0.220439895 +-0.260397404 +-0.295844272 +-0.326276862 +-0.351171996 +-0.370063377 +-0.382705185 +-0.388829024 +-0.388374764 +-0.381362818 +-0.367876886 +-0.348230675 +-0.322667154 +-0.291712391 +-0.255838496 +-0.21562818 +-0.171850417 +-0.125100999 +-0.0762501789 +-0.0261141172 +0.0245714309 +0.0749256274 +0.12408148 +0.171291739 +0.215833161 +0.256918063 +0.293892951 +0.326191738 +0.353301169 +0.374796295 +0.390336772 +0.399666419 +0.40266057 +0.39927908 +0.389582824 +0.373732142 +0.351983703 +0.324685883 +0.292272733 +0.25525665 +0.214219882 +0.169805012 +0.122704586 +0.0736500483 +0.0234001798 +-0.0272707905 +-0.0775852001 +-0.126773912 +-0.174123937 +-0.218853621 +-0.260303395 +-0.297859827 +-0.330961265 +-0.359120938 +-0.38193314 +-0.399008854 +-0.410137771 +-0.41516266 +-0.414002049 +-0.406687298 +-0.39334524 +-0.374139596 +-0.349403937 +-0.319522507 +-0.284846882 +-0.24600439 +-0.203540891 +-0.157959338 +-0.110149189 +-0.0605851515 +-0.0101465383 +0.0405107373 +0.0906659729 +0.139520782 +0.186495824 +0.230775853 +0.27187564 +0.309083734 +0.341971635 +0.370020045 +0.392850976 +0.410171259 +0.421695202 +0.427315294 +0.426924627 +0.420554678 +0.408276303 +0.390313197 +0.366873515 +0.338292586 +0.30503189 +0.26749608 +0.226172487 +0.181757702 +0.134796825 +0.0858786537 +0.0357452348 +-0.014889205 +-0.0653763852 +-0.115040394 +-0.163247332 +-0.209224152 +-0.252421165 +-0.292257836 +-0.328200435 +-0.359771564 +-0.38656507 +-0.408178873 +-0.424360209 +-0.434898032 +-0.439657053 +-0.438579203 +-0.431684043 +-0.419068151 +-0.400903483 +-0.377434748 +-0.348975835 +-0.315905355 +-0.278661351 +-0.237735269 +-0.193665262 +-0.147028929 +-0.0984355902 +-0.0485181942 +0.00207501936 +0.0526890035 +0.102670413 +0.151376035 +0.198181023 +0.24248684 +0.283764024 +0.321419424 +0.355001009 +0.384092765 +0.408329978 +0.427410661 +0.441106408 +0.449226888 +0.451680063 +0.448451443 +0.439588001 +0.425171094 +0.405430959 +0.380615604 +0.351036147 +0.316976632 +0.279016619 +0.237571805 +0.193087964 +0.146177812 +0.0974860705 +0.0474924595 +-0.00315348965 +-0.0537153563 +-0.103751099 +-0.152536732 +-0.199433628 +-0.244076699 +-0.28566036 +-0.323855821 +-0.358173449 +-0.388119084 +-0.413489554 +-0.433800835 +-0.448959109 +-0.458696225 +-0.46294683 +-0.461645785 +-0.454816359 +-0.442549004 +-0.424985986 +-0.402356245 +-0.374904241 +-0.343014278 +-0.306973113 +-0.26736513 +-0.224426885 +-0.178964529 +-0.131212295 +-0.0819835301 +-0.0317218584 +0.0190044259 +0.0694358268 +0.119245307 +0.167596013 +0.2140312 +0.258132636 +0.29914936 +0.336772901 +0.370589513 +0.400077901 +0.42500042 +0.445095678 +0.460042941 +0.469738718 +0.474073279 +0.472979543 +0.466493138 +0.454693984 +0.437669853 +0.415692214 +0.388989883 +0.357865487 +0.322619915 +0.283722951 +0.241624204 +0.196774108 +0.149677653 +0.100816854 +0.0507977638 +0.000207809749 +-0.050424871 +-0.100536034 +-0.149568363 +-0.19697764 +-0.242284028 +-0.284892313 +-0.324375841 +-0.360306105 +-0.392289058 +-0.419974965 +-0.443062101 +-0.461299911 +-0.474491582 +-0.48249602 +-0.485229198 +-0.482664882 +-0.474834708 +-0.461827637 +-0.443785014 +-0.42091434 +-0.393463958 +-0.361734337 +-0.32607158 +-0.286859218 +-0.244522787 +-0.199527749 +-0.152355978 +-0.103515488 +-0.0535310565 +-0.00293852986 +0.0477209504 +0.0979067539 +0.147084529 +0.194731871 +0.24034384 +0.283438249 +0.323560697 +0.360301435 +0.393274528 +0.422090862 +0.446481648 +0.466194098 +0.481025138 +0.49082334 +0.495489947 +0.494967583 +0.4892729 +0.478474761 +0.462689829 +0.442086257 +0.416817668 +0.387256362 +0.353669531 +0.316407197 +0.275809067 +0.232318572 +0.186466877 +0.138671233 +0.0893661129 +0.0390832112 +-0.0115498396 +-0.0620960885 +-0.112152502 +-0.161021008 +-0.208243427 +-0.25343245 +-0.296106417 +-0.335715049 +-0.371978727 +-0.404559441 +-0.432982121 +-0.457082036 +-0.476619037 +-0.491316744 +-0.501108304 +-0.505866032 +-0.505550417 +-0.500159374 +-0.489766261 +-0.474487262 +-0.454404046 +-0.429857354 +-0.400936974 +-0.368059236 +-0.331511997 +-0.291581309 +-0.248876037 +-0.20346938 +-0.156246171 +-0.107273705 +-0.0573436293 +-0.00672824295 +0.0439350466 +0.0942177739 +0.143615455 +0.191612524 +0.237801498 +0.281656124 +0.322827064 +0.360847996 +0.395397357 +0.426121384 +0.452714463 +0.474959918 +0.492582451 +0.50549187 +0.513488421 +0.516558457 +0.514644276 +0.507766172 +0.496012857 +0.479496519 +0.458330874 +0.432839054 +0.403082596 +0.369547983 +0.332449776 +0.292085517 +0.249041991 +0.203481789 +0.156015809 +0.107112211 +0.056982182 +0.00644033203 +-0.0441758049 +-0.0945974431 +-0.143965766 +-0.192015013 +-0.238456604 +-0.2825189 +-0.323963935 +-0.362506525 +-0.397594219 +-0.428968525 +-0.456398419 +-0.479591427 +-0.498286915 +-0.512366863 +-0.521713923 +-0.526197328 +-0.52580683 +-0.520553834 +-0.510451002 +-0.495640825 +-0.476256114 +-0.452474076 +-0.424461989 +-0.392540544 +-0.357024031 +-0.318212538 +-0.276462624 +-0.232060259 +-0.185589184 +-0.137406853 +-0.0879425439 +-0.0376471736 +0.0130702829 +0.0637009225 +0.113728572 +0.162753847 +0.210333136 +0.256036542 +0.299451745 +0.340247449 +0.377926412 +0.412219181 +0.442820039 +0.469455532 +0.491888231 +0.509918776 +0.52338757 +0.532177548 +0.53620553 +0.535436911 +0.529887814 +0.519610066 +0.504697547 +0.485285248 +0.461547969 +0.433698661 +0.401986443 +0.366694295 +0.328136468 +0.286655621 +0.242619716 +0.196418704 +0.148461025 +0.0991699587 +0.0489798595 +-0.00166769713 +-0.0523278133 +-0.102556184 +-0.151912994 +-0.199966757 +-0.246298073 +-0.290503262 +-0.332197849 +-0.371019862 +-0.406632934 +-0.438729153 +-0.46703167 +-0.491297015 +-0.511317118 +-0.526921019 +-0.537976241 +-0.544389831 +-0.546109057 +-0.543121745 +-0.535456275 +-0.523181222 +-0.506388748 +-0.485238997 +-0.459924713 +-0.430658354 +-0.397692636 +-0.361311462 +-0.321827408 +-0.279578969 +-0.234927604 +-0.188198583 +-0.139869584 +-0.0903544495 +-0.0400490971 +0.0106198356 +0.0612233833 +0.111333885 +0.160617915 +0.208489621 +0.254614282 +0.298616467 +0.340127625 +0.378815437 +0.414390428 +0.446429647 +0.474744023 +0.499099247 +0.519300286 +0.535193229 +0.546581907 +0.553421628 +0.555658491 +0.553264602 +0.546255553 +0.534714279 +0.518736375 +0.498426439 +0.473946996 +0.44558172 +0.413526831 +0.377985174 +0.339289394 +0.297850786 +0.253946479 +0.207797554 +0.160013364 +0.110933504 +0.0608641127 +0.0101944287 +-0.0404449643 +-0.0907762832 +-0.140587021 +-0.189075555 +-0.23604409 +-0.281264523 +-0.324094378 +-0.364278047 +-0.401644658 +-0.435678054 +-0.466164786 +-0.492988425 +-0.515750948 +-0.534346171 +-0.548696745 +-0.558558204 +-0.563938915 +-0.564774264 +-0.561064768 +-0.552829637 +-0.540140813 +-0.523153833 +-0.501861422 +-0.476635367 +-0.447541204 +-0.414814154 +-0.378873645 +-0.339693931 +-0.297976916 +-0.253760725 +-0.207511923 +-0.159679462 +-0.110364854 +-0.0603952796 +-0.00966997189 +0.0409396477 +0.0913836835 +0.141068737 +0.189651401 +0.236829515 +0.282036729 +0.325206234 +0.365635612 +0.403424207 +0.437835675 +0.469027238 +0.496371153 +0.519979157 +0.53940771 +0.554710475 +0.565615519 +0.572147851 +0.574194007 +0.571759985 +0.564894283 +0.553571956 +0.538021202 +0.518165182 +0.494409482 +0.466668795 +0.43542891 +0.400688688 +0.362916707 +0.322278476 +0.279123778 +0.233868889 +0.186643489 +0.138180404 +0.0883409347 +0.0380801741 +-0.0126783442 +-0.0632809145 +-0.113390521 +-0.162793805 +-0.210763299 +-0.257368614 +-0.301851411 +-0.344098458 +-0.383803854 +-0.420464459 +-0.454095113 +-0.484168907 +-0.510587512 +-0.533207275 +-0.551699838 +-0.566069089 +-0.576139783 +-0.581841501 +-0.583154524 +-0.580052636 +-0.572588998 +-0.560742385 +-0.544721467 +-0.524596542 +-0.500418406 +-0.472572534 +-0.441158275 +-0.406289884 +-0.368503808 +-0.327941715 +-0.284721279 +-0.239541202 +-0.192556239 +-0.143928269 +-0.0943547779 +-0.0440901855 +0.00664358318 +0.057331108 +0.107515855 +0.156947641 +0.205393121 +0.252155123 +0.297074283 +0.339902062 +0.380220402 +0.417668987 +0.452056293 +0.483209346 +0.510743205 +0.534504438 +0.554348846 +0.570165816 +0.581754164 +0.589071288 +0.592076159 +0.590736041 +0.585055623 +0.575098293 +0.560936106 +0.542660786 +0.520359524 +0.494305944 +0.464641667 +0.431583344 +0.395324591 +0.356145118 +0.314428645 +0.27041332 +0.224418605 +0.176747008 +0.127699847 +0.0778108602 +0.0273386166 +-0.0233524655 +-0.0738967477 +-0.123994577 +-0.173207916 +-0.221135165 +-0.267491094 +-0.311943093 +-0.354172547 +-0.393886028 +-0.430845464 +-0.464653197 +-0.495146301 +-0.522107675 +-0.545345681 +-0.564695468 +-0.580020105 +-0.591219467 +-0.598191442 +-0.600895831 +-0.59932265 +-0.593484498 +-0.583424269 +-0.569214803 +-0.550958311 +-0.528785602 +-0.502844382 +-0.473305423 +-0.440432318 +-0.404431272 +-0.36555775 +-0.324087229 +-0.280313223 +-0.234545179 +-0.187106267 +-0.138331081 +-0.0885632644 +-0.0381530747 +0.0125450884 +0.0631751805 +0.113382015 +0.162847432 +0.211154915 +0.258001886 +0.303062343 +0.346022012 +0.386581633 +0.424459024 +0.459391021 +0.491135272 +0.519471895 +0.544204962 +0.565163821 +0.582204236 +0.595209341 +0.604090398 +0.608787363 +0.60926925 +0.605534288 +0.597609883 +0.58555237 +0.569446572 +0.549405163 +0.525567832 +0.498100273 +0.467192996 +0.433059965 +0.395937079 +0.356080518 +0.313764935 +0.269281539 +0.22293607 +0.175044376 +0.125902957 +0.0759154587 +0.0253913386 +-0.0253241225 +-0.0758847416 +-0.125945796 +-0.175166373 +-0.223211681 +-0.26975532 +-0.314481484 +-0.357087083 +-0.397283783 +-0.434799923 +-0.469382335 +-0.500815733 +-0.52886934 +-0.553330449 +-0.57406022 +-0.590920245 +-0.603798391 +-0.6126095 +-0.617295909 +-0.617827782 +-0.614203256 +-0.606431565 +-0.594580248 +-0.578737133 +-0.559006478 +-0.535522151 +-0.508442977 +-0.477951625 +-0.44425334 +-0.407491982 +-0.368058723 +-0.326162965 +-0.282078538 +-0.236099944 +-0.18853391 +-0.13967564 +-0.0897840598 +-0.0393833214 +0.0112950207 +0.0619149594 +0.112141299 +0.161660609 +0.210224384 +0.257292009 +0.302674161 +0.346072234 +0.38720107 +0.425860583 +0.461685525 +0.49443714 +0.523946223 +0.550020513 +0.572523129 +0.59125325 +0.606074907 +0.616928731 +0.623745574 +0.626478827 +0.625092363 +0.619618004 +0.610095901 +0.596574778 +0.579105165 +0.557896099 +0.533048426 +0.504725201 +0.472980368 +0.438250705 +0.400672964 +0.360484758 +0.317787654 +0.273132778 +0.22672318 +0.178833112 +0.129568809 +0.0796309914 +0.0291795661 +-0.0215115017 +-0.0722367379 +-0.122318616 +-0.171628405 +-0.219964041 +-0.266885611 +-0.311997953 +-0.355122815 +-0.396171161 +-0.43448686 +-0.470031971 +-0.502667832 +-0.532052918 +-0.557980294 +-0.580380834 +-0.599109166 +-0.613940276 +-0.62486884 +-0.631837556 +-0.634735175 +-0.633602152 +-0.628402078 +-0.619211664 +-0.60609775 +-0.589045485 +-0.568295496 +-0.543963583 +-0.516039528 +-0.484928063 +-0.450777318 +-0.413565768 +-0.37388855 +-0.33186715 +-0.28747506 +-0.241512848 +-0.193960623 +-0.144987767 +-0.0953261656 +-0.0449128897 +0.00583813406 +0.0563890344 +0.106834734 +0.156475041 +0.205085509 +0.252689183 +0.298433408 +0.3424568 +0.384368387 +0.423739265 +0.46068937 +0.494579732 +0.525444027 +0.553087647 +0.57717101 +0.597787 +0.614579444 +0.627579903 +0.636681131 +0.641797518 +0.642935357 +0.640071658 +0.633218759 +0.622431019 +0.607803919 +0.589324189 +0.56730567 +0.541603338 +0.512694512 +0.480497205 +0.445361498 +0.407489751 +0.366979415 +0.324386039 +0.279490546 +0.233186879 +0.185107995 +0.136158733 +0.0861406931 +0.0357224656 +-0.0150089187 +-0.0656516965 +-0.115859029 +-0.165475389 +-0.213939092 +-0.261303184 +-0.306850283 +-0.350792338 +-0.392323957 +-0.431759761 +-0.468276719 +-0.50223482 +-0.53286434 +-0.560503128 +-0.584513971 +-0.605159548 +-0.621972063 +-0.63513099 +-0.644338727 +-0.649696625 +-0.651081561 +-0.648511249 +-0.642042656 +-0.631617277 +-0.617448255 +-0.599435533 +-0.577901101 +-0.552754895 +-0.524364321 +-0.492712479 +-0.458137151 +-0.420765036 +-0.380822645 +-0.338652782 +-0.294288194 +-0.248356581 +-0.200619836 +-0.152009598 +-0.10211145 +-0.0519072151 +-0.00114749281 +0.0495034889 +0.0998994238 +0.149792505 +0.198615537 +0.246560809 +0.292719558 +0.337425907 +0.379931029 +0.420264237 +0.458131669 +0.493153894 +0.525462814 +0.55443599 +0.580263827 +0.60258262 +0.621322615 +0.636438814 +0.647709433 +0.655196168 +0.658772105 +0.658458507 +0.654230675 +0.646164651 +0.634224378 +0.618569222 +0.59928185 +0.576340708 +0.550134988 +0.520577104 +0.487956044 +0.452565897 +0.414268975 +0.373732867 +0.330965382 +0.286061909 +0.239707825 +0.191785288 +0.142704342 +0.0929456584 +0.0423961139 +-0.00828624777 +-0.0588360046 +-0.109342932 +-0.158982624 +-0.207674075 +-0.255472049 +-0.301491347 +-0.34579758 +-0.388328682 +-0.428365611 +-0.465956951 +-0.501023013 +-0.532992448 +-0.561901421 +-0.587692883 +-0.609934278 +-0.628664068 +-0.643840941 +-0.6552073 +-0.662799243 +-0.66657776 +-0.666482722 +-0.662549844 +-0.654769559 +-0.643200913 +-0.627954489 +-0.609065479 +-0.586593209 +-0.560829531 +-0.531843325 +-0.499631518 +-0.464667896 +-0.42705493 +-0.386891178 +-0.344451936 +-0.300157101 +-0.254134051 +-0.206422865 +-0.157698331 +-0.108091955 +-0.0577952959 +-0.00701059922 +0.0436286797 +0.0940351728 +0.144039557 +0.193244756 +0.24123574 +0.287871276 +0.333016405 +0.376221578 +0.417221974 +0.4558699 +0.492046787 +0.525384427 +0.555696138 +0.582873401 +0.606811958 +0.627301117 +0.644200585 +0.657468102 +0.667036175 +0.672836941 +0.674815427 +0.672992295 +0.667378476 +0.657960236 +0.644846525 +0.628109712 +0.607837684 +0.584119954 +0.557039513 +0.526901123 +0.49379858 +0.457917746 +0.419394198 +0.378470517 +0.33550577 +0.290651444 +0.244158398 +0.196220097 +0.147117245 +0.0972935856 +0.0469126795 +-0.0037446702 +-0.05440401 +-0.104935934 +-0.154724575 +-0.203665878 +-0.251487988 +-0.297925437 +-0.342778554 +-0.385757722 +-0.426517135 +-0.464920691 +-0.500756019 +-0.533825102 +-0.563977792 +-0.591020651 +-0.614740659 +-0.635065499 +-0.651883544 +-0.665102595 +-0.674650372 +-0.680480384 +-0.682530716 +-0.680814346 +-0.675343265 +-0.666148382 +-0.653281076 +-0.636812885 +-0.61678499 +-0.593382304 +-0.566720806 +-0.536937874 +-0.504197652 +-0.468680394 +-0.430581452 +-0.390110194 +-0.347389531 +-0.302840743 +-0.256626756 +-0.208995742 +-0.160208449 +-0.110531766 +-0.0602372576 +-0.00959967581 +0.0411045413 +0.0916972331 +0.141704452 +0.190949522 +0.239167346 +0.286095655 +0.331479375 +0.37507201 +0.416636967 +0.455948832 +0.492794585 +0.526986662 +0.55834957 +0.586648241 +0.611773983 +0.633591409 +0.651983138 +0.666850408 +0.678113594 +0.685712612 +0.689607221 +0.689777219 +0.686222527 +0.678963169 +0.668039134 +0.653510144 +0.635431269 +0.613941797 +0.58914197 +0.561165754 +0.530164345 +0.496305089 +0.459770567 +0.420757592 +0.37947614 +0.336148204 +0.29100659 +0.244293658 +0.196260009 +0.147163134 +0.097266027 +0.0468357731 +-0.00385788752 +-0.0545440032 +-0.10495186 +-0.154812429 +-0.203859795 +-0.25183258 +-0.298475324 +-0.34353984 +-0.386786534 +-0.427985663 +-0.466918547 +-0.503378722 +-0.537173021 +-0.568122582 +-0.596063784 +-0.620849093 +-0.642347828 +-0.660446833 +-0.675051053 +-0.686084016 +-0.693488215 +-0.697225389 +-0.697276701 +-0.693642811 +-0.686343853 +-0.675419299 +-0.660927727 +-0.642946493 +-0.62157129 +-0.596915628 +-0.569110211 +-0.538302223 +-0.504654538 +-0.468344841 +-0.42956467 +-0.388518401 +-0.345422149 +-0.300502624 +-0.253995924 +-0.206146287 +-0.157204801 +-0.107428077 +-0.057076899 +-0.00641485623 +0.0442930423 +0.0947817537 +0.144787586 +0.194049573 +0.242321755 +0.289373635 +0.334883153 +0.378657958 +0.420470517 +0.460103692 +0.497351858 +0.532021955 +0.563934476 +0.592924384 +0.618841945 +0.641553486 +0.660942072 +0.676908081 +0.689369707 +0.698268481 +0.703543021 +0.705171347 +0.703152395 +0.697497633 +0.688237295 +0.675420205 +0.6591135 +0.639402256 +0.616389027 +0.590193294 +0.56092028 +0.528736338 +0.493857022 +0.456429414 +0.416646615 +0.374713659 +0.330846448 +0.285270629 +0.238220421 +0.189926174 +0.14054712 +0.0905423042 +0.0400629383 +-0.0106325968 +-0.0612850315 +-0.111635532 +-0.161427022 +-0.210405487 +-0.258428961 +-0.30505097 +-0.350107128 +-0.393388153 +-0.434674193 +-0.473755728 +-0.510434619 +-0.544561187 +-0.575936504 +-0.604328752 +-0.629656842 +-0.651793206 +-0.670626552 +-0.686062405 +-0.698037576 +-0.706459712 +-0.711286655 +-0.7125137 +-0.710135741 +-0.704165872 +-0.694630033 +-0.681534007 +-0.665022363 +-0.64515069 +-0.622020158 +-0.595748239 +-0.566456683 +-0.534198029 +-0.499339785 +-0.46196162 +-0.422252067 +-0.380411181 +-0.336579679 +-0.291001222 +-0.244055075 +-0.195874859 +-0.146702192 +-0.0967834365 +-0.0461684929 +0.00449921754 +0.0551476466 +0.105530777 +0.155397238 +0.204656741 +0.252786681 +0.299616572 +0.344961167 +0.388595226 +0.430439788 +0.47003304 +0.507253457 +0.541956914 +0.573971929 +0.603258194 +0.629410541 +0.652438635 +0.672232454 +0.688715766 +0.701785239 +0.711325962 +0.717344246 +0.719811495 +0.718696831 +0.714008952 +0.705790479 +0.694082225 +0.678897987 +0.66032771 +0.638535557 +0.613589664 +0.585575695 +0.55456486 +0.520928798 +0.484721988 +0.446099799 +0.405088347 +0.36226373 +0.317651277 +0.271449362 +0.223675466 +0.175030422 +0.125518001 +0.0753382297 +0.0245738099 +-0.0260779771 +-0.0766118251 +-0.126869022 +-0.176625158 +-0.225324685 +-0.272933332 +-0.319364494 +-0.364210233 +-0.407162699 +-0.448139429 +-0.48713254 +-0.523575935 +-0.557445338 +-0.588654193 +-0.617073287 +-0.64235382 +-0.664519843 +-0.683534661 +-0.699159873 +-0.711362465 +-0.720127666 +-0.725396013 +-0.727109055 +-0.725303935 +-0.719942804 +-0.711093084 +-0.698812634 +-0.683097844 +-0.664035445 +-0.641823792 +-0.616485841 +-0.588008451 +-0.556841154 +-0.522987037 +-0.486369989 +-0.447581204 +-0.406662586 +-0.363567002 +-0.31880761 +-0.272606768 +-0.22490711 +-0.176120985 +-0.126645253 +-0.076403647 +-0.0257133324 +0.0248926475 +0.0755136084 +0.125901967 +0.175449496 +0.224277523 +0.272172793 +0.318523803 +0.363467561 +0.406791265 +0.447950335 +0.487086298 +0.523964832 +0.558164598 +0.589816626 +0.618663884 +0.64444019 +0.667248661 +0.68683534 +0.703088986 +0.716066749 +0.725573276 +0.731615781 +0.734188742 +0.733239508 +0.72881376 +0.7208591 +0.709529285 +0.694794044 +0.676695077 +0.65547963 +0.631024488 +0.603608248 +0.573420327 +0.540244056 +0.504737386 +0.466779393 +0.42643076 +0.384312541 +0.340136579 +0.294425097 +0.247471212 +0.198915147 +0.149830956 +0.0998557865 +0.0493119872 +-0.00120713864 +-0.0521078841 +-0.10246907 +-0.152413284 +-0.201835729 +-0.250001846 +-0.297330129 +-0.343038124 +-0.387155323 +-0.429641815 +-0.469833466 +-0.508106024 +-0.5437957 +-0.576977365 +-0.607552365 +-0.635098277 +-0.659881151 +-0.681395302 +-0.699792188 +-0.714912889 +-0.726634073 +-0.735027825 +-0.739913451 +-0.741364067 +-0.739335627 +-0.733859061 +-0.724912849 +-0.712655907 +-0.696926272 +-0.678089373 +-0.655968904 +-0.630838819 +-0.602779165 +-0.571791903 +-0.538349859 +-0.502055137 +-0.46377808 +-0.42303648 +-0.38052653 +-0.336136687 +-0.290159351 +-0.242959581 +-0.194360167 +-0.145234627 +-0.0949113659 +-0.0446603529 +0.00622570142 +0.0567847316 +0.107289747 +0.157216343 +0.206414749 +0.254774526 +0.30176927 +0.347654918 +0.391593342 +0.434142003 +0.474269045 +0.512602422 +0.548243135 +0.581621906 +0.612128393 +0.639958109 +0.664751692 +0.68654034 +0.705148929 +0.720515208 +0.73258232 +0.741261932 +0.746553494 +0.748403339 +0.746812129 +0.741812368 +0.733360019 +0.72161396 +0.706450491 +0.688182327 +0.666583216 +0.642133662 +0.614494519 +0.584314433 +0.551143379 +0.515785491 +0.477693412 +0.437802303 +0.39549115 +0.351791677 +0.30604106 +0.259325413 +0.210977751 +0.162091381 +0.112035891 +0.0618625534 +0.0110184014 +-0.0395354347 +-0.0902364997 +-0.140257601 +-0.189888789 +-0.238473198 +-0.286130062 +-0.33239895 +-0.377216273 +-0.420331348 +-0.461499211 +-0.500677403 +-0.537456136 +-0.571983328 +-0.603717054 +-0.632960615 +-0.659089136 +-0.682509057 +-0.70260508 +-0.719709085 +-0.733440193 +-0.743937932 +-0.751039207 +-0.754768019 +-0.755088769 +-0.752011238 +-0.745520254 +-0.735724164 +-0.722510548 +-0.706183415 +-0.686501472 +-0.663900246 +-0.638171248 +-0.609655385 +-0.57837732 +-0.544427925 +-0.508197109 +-0.469393151 +-0.428833924 +-0.385959587 +-0.341682699 +-0.29565572 +-0.24836902 +-0.200037996 +-0.150566722 +-0.100789004 +-0.0500549093 +0.000443650151 +0.0512435117 +0.101709321 +0.151663797 +0.201198551 +0.24947493 +0.297080361 +0.34300124 +0.387583694 +0.430446346 +0.471234536 +0.510253988 +0.546664687 +0.580893759 +0.612427521 +0.641226124 +0.667319896 +0.690269909 +0.710325719 +0.727124779 +0.740724471 +0.75108041 +0.758053441 +0.761709513 +0.76197121 +0.758871012 +0.752382611 +0.742622377 +0.72949276 +0.713198806 +0.693769338 +0.671143586 +0.645729844 +0.617303984 +0.586214035 +0.552645489 +0.516320766 +0.478043896 +0.437506874 +0.394966881 +0.35091692 +0.304986257 +0.257942977 +0.209803811 +0.160390247 +0.110660375 +0.0602349864 +0.00947714904 +-0.0410732077 +-0.0917894337 +-0.141900803 +-0.191283442 +-0.240276034 +-0.287789138 +-0.33416214 +-0.379284339 +-0.422457786 +-0.463971663 +-0.503483588 +-0.540625484 +-0.575621651 +-0.6080087 +-0.637665792 +-0.664743962 +-0.688772704 +-0.709786731 +-0.727861674 +-0.742624805 +-0.754182331 +-0.762517254 +-0.767471267 +-0.769111815 +-0.767393561 +-0.762354558 +-0.754007105 +-0.74231956 +-0.727487857 +-0.709478899 +-0.688286536 +-0.664243779 +-0.637283336 +-0.607412349 +-0.575097965 +-0.540250024 +-0.502856141 +-0.463529946 +-0.422168621 +-0.378692847 +-0.333885335 +-0.287635623 +-0.239755586 +-0.191204876 +-0.141827383 +-0.0914923312 +-0.0410271522 +0.00956304032 +0.0603860667 +0.110827289 +0.160670824 +0.210004563 +0.25848193 +0.305651088 +0.351587025 +0.39623161 +0.438904738 +0.479712746 +0.518728405 +0.555293985 +0.589464306 +0.621246844 +0.65033927 +0.676557262 +0.699922236 +0.720390084 +0.737649252 +0.751772455 +0.762741373 +0.770403216 +0.774768957 +0.77583832 +0.773574517 +0.768019089 +0.759201043 +0.747079977 +0.731796535 +0.713429632 +0.692008436 +0.667504062 +0.640296341 +0.610370132 +0.577727465 +0.542613776 +0.505307192 +0.465854622 +0.424177882 +0.380871326 +0.335995541 +0.289663685 +0.241822729 +0.193239848 +0.143831525 +0.0937119713 +0.0430362078 +-0.00758958737 +-0.0581933451 +-0.108697309 +-0.15880585 +-0.208060003 +-0.256447573 +-0.303907853 +-0.350098402 +-0.394664959 +-0.437580145 +-0.478782331 +-0.517973011 +-0.554857353 +-0.589417871 +-0.621583724 +-0.651160514 +-0.677889519 +-0.701779384 +-0.722757611 +-0.74074227 +-0.755528587 +-0.767151662 +-0.775563636 +-0.780740267 +-0.78259989 +-0.781184513 +-0.776500389 +-0.768522064 +-0.757323065 +-0.742971038 +-0.725511603 +-0.70497982 +-0.681419612 +-0.655096612 +-0.626034703 +-0.594355152 +-0.560030625 +-0.523454542 +-0.484734469 +-0.443987174 +-0.401343134 +-0.356842148 +-0.311047707 +-0.263950361 +-0.21574578 +-0.166516205 +-0.116546067 +-0.0662333598 +-0.0156360693 +0.0350360239 +0.0857312118 +0.136025754 +0.185656147 +0.234525632 +0.282432006 +0.329324195 +0.374788963 +0.418618683 +0.46072269 +0.500927154 +0.539160397 +0.575145049 +0.608664794 +0.639673689 +0.668044046 +0.693688766 +0.716506892 +0.736277714 +0.753012202 +0.766641754 +0.777110565 +0.784392362 +0.788399695 +0.789152582 +0.786653526 +0.780913184 +0.771941288 +0.75974438 +0.744449664 +0.726089225 +0.704738847 +0.680486543 +0.653370665 +0.623538906 +0.591205419 +0.556438274 +0.519380312 +0.480183693 +0.438924671 +0.395832048 +0.35120533 +0.305131144 +0.25779823 +0.209400399 +0.160092388 +0.10999771 +0.0596059765 +0.00896157072 +-0.0417285836 +-0.0922574599 +-0.142418773 +-0.192141098 +-0.2410083 +-0.288838567 +-0.33549817 +-0.380797044 +-0.424550739 +-0.466581173 +-0.506841043 +-0.544924018 +-0.580771853 +-0.614260407 +-0.64525375 +-0.673626143 +-0.699262549 +-0.722107097 +-0.741976855 +-0.758806635 +-0.772555433 +-0.783167839 +-0.790601182 +-0.794825698 +-0.79582413 +-0.793575359 +-0.788104217 +-0.779436266 +-0.767607046 +-0.752664875 +-0.734670646 +-0.713697571 +-0.689830874 +-0.663077534 +-0.633707378 +-0.601771875 +-0.567397522 +-0.53072351 +-0.491898253 +-0.451078783 +-0.408430113 +-0.364089516 +-0.31820174 +-0.27112005 +-0.22293689 +-0.173846588 +-0.124047037 +-0.0737389038 +-0.0231248153 +0.0275914555 +0.0782058106 +0.128621087 +0.178445716 +0.227532398 +0.27571245 +0.322792428 +0.368583385 +0.412901631 +0.455569464 +0.496415878 +0.535277245 +0.57202538 +0.606506573 +0.638501361 +0.667942241 +0.694711654 +0.718702786 +0.739819986 +0.757979144 +0.773108016 +0.785146505 +0.794046894 +0.799774026 +0.802304766 +0.8016202 +0.797730859 +0.790655525 +0.780422892 +0.767074234 +0.750663232 +0.73125575 +0.708929566 +0.683774049 +0.655889799 +0.625388238 +0.592391154 +0.557030215 +0.519411677 +0.479715965 +0.4381393 +0.39481407 +0.349912684 +0.303613731 +0.25610127 +0.207564095 +0.158194982 +0.108189922 +0.0577473392 +0.00706730502 +-0.0436492572 +-0.0942013689 +-0.144388792 +-0.194012823 +-0.242877076 +-0.290788258 +-0.337591588 +-0.383052523 +-0.42698161 +-0.469229922 +-0.509630773 +-0.54802485 +-0.584260837 +-0.618196007 +-0.649696777 +-0.67863923 +-0.704909592 +-0.728404681 +-0.749032299 +-0.766711589 +-0.781373344 +-0.792960276 +-0.801427223 +-0.806741328 +-0.808882151 +-0.807841744 +-0.803624671 +-0.796247982 +-0.785741136 +-0.772145874 +-0.75551605 +-0.735917405 +-0.713427302 +-0.688134418 +-0.660138379 +-0.629549367 +-0.596487678 +-0.561078073 +-0.523457129 +-0.483792331 +-0.442227405 +-0.398925301 +-0.354055691 +-0.307794296 +-0.260322198 +-0.211825126 +-0.162492727 +-0.112517824 +-0.0620956557 +-0.0114231171 +0.0393020126 +0.0898818416 +0.140119138 +0.189818098 +0.238785108 +0.286829497 +0.33376428 +0.379406877 +0.423579829 +0.466111475 +0.506836624 +0.545597188 +0.582242789 +0.616631345 +0.648629605 +0.678113671 +0.704969463 +0.729093157 +0.750391581 +0.768782567 +0.784195261 +0.796570388 +0.805860474 +0.812030911 +0.815054613 +0.814921825 +0.811634661 +0.805206358 +0.795662296 +0.783039894 +0.767388456 +0.748768965 +0.727253846 +0.702926671 +0.675881829 +0.646224156 +0.614068514 +0.57953935 +0.5427702 +0.503903171 +0.463088385 +0.420483393 +0.376252565 +0.33056645 +0.283601114 +0.235537458 +0.18656052 +0.136858758 +0.0866233236 +0.0360473266 +-0.0146749104 +-0.0653485983 +-0.115779229 +-0.165773324 +-0.21513917 +-0.263742343 +-0.311293159 +-0.35764993 +-0.402642982 +-0.446100209 +-0.487855475 +-0.527749238 +-0.565629163 +-0.601350689 +-0.634777584 +-0.665782453 +-0.69424722 +-0.720063573 +-0.743133363 +-0.763368978 +-0.780693662 +-0.795041805 +-0.806359178 +-0.814607967 +-0.819743314 +-0.821748025 +-0.820621944 +-0.816369915 +-0.809008679 +-0.798566799 +-0.785084541 +-0.768613711 +-0.74921745 +-0.726969984 +-0.701956329 +-0.674271965 +-0.64402246 +-0.611314967 +-0.576216607 +-0.538989575 +-0.499712708 +-0.45853528 +-0.415613691 +-0.371110864 +-0.325195627 +-0.278042067 +-0.229828865 +-0.180738621 +-0.130957158 +-0.0806728149 +-0.0299729524 +0.0207703088 +0.0714183894 +0.121803632 +0.171735874 +0.221026763 +0.269490461 +0.316944345 +0.363209691 +0.408112344 +0.451483371 +0.493259766 +0.533085584 +0.570897975 +0.606566143 +0.639956317 +0.670943359 +0.699411222 +0.725253383 +0.748373232 +0.768684425 +0.786154713 +0.800614274 +0.812069594 +0.82047872 +0.825810698 +0.82804611 +0.827177149 +0.823207625 +0.816152952 +0.806003679 +0.792845333 +0.776722426 +0.757690542 +0.73582138 +0.711197195 +0.683910481 +0.654063621 +0.62173279 +0.587013978 +0.550178078 +0.511283545 +0.470475794 +0.427907287 +0.383736958 +0.338129618 +0.291211638 +0.243105654 +0.194218822 +0.144602477 +0.0944412683 +0.0439217679 +-0.00676822295 +-0.0574403705 +-0.108026838 +-0.158172683 +-0.207661078 +-0.256384589 +-0.304162659 +-0.35081833 +-0.396178896 +-0.440135308 +-0.482512972 +-0.522988335 +-0.561530645 +-0.597997669 +-0.632254919 +-0.66417614 +-0.693686851 +-0.720648878 +-0.744869564 +-0.766338899 +-0.784978171 +-0.800719144 +-0.813504295 +-0.823307327 +-0.830038021 +-0.83369206 +-0.834270501 +-0.831771824 +-0.82620582 +-0.817581103 +-0.805895598 +-0.791270256 +-0.773729064 +-0.753337086 +-0.730169807 +-0.704312848 +-0.675713169 +-0.644747693 +-0.611409025 +-0.575819415 +-0.538109815 +-0.498418862 +-0.45668687 +-0.41345166 +-0.368703158 +-0.322596681 +-0.275301233 +-0.226966072 +-0.17758457 +-0.127769276 +-0.0774800698 +-0.0269007844 +0.023783795 +0.0744935037 +0.124991175 +0.174877438 +0.22413066 +0.272571386 +0.320023216 +0.366519031 +0.411502303 +0.454950751 +0.496745009 +0.536733331 +0.574856872 +0.610900456 +0.644602935 +0.675961723 +0.704863387 +0.731223285 +0.755003015 +0.77591129 +0.794000443 +0.809205464 +0.821471805 +0.83079068 +0.83702321 +0.840216362 +0.840360277 +0.837455049 +0.831461768 +0.822462563 +0.810483551 +0.795565957 +0.777764271 +0.757004519 +0.733601248 +0.707543856 +0.678923197 +0.647819354 +0.61419162 +0.57851038 +0.540734468 +0.501000394 +0.459355999 +0.415949755 +0.371208575 +0.325122802 +0.27785843 +0.229372777 +0.18015179 +0.130378976 +0.0801304381 +0.0295625272 +-0.0214044181 +-0.0719918756 +-0.122326146 +-0.17222685 +-0.221694592 +-0.270330388 +-0.317852338 +-0.364238301 +-0.409353591 +-0.453229006 +-0.495207644 +-0.535414573 +-0.573706488 +-0.610118296 +-0.64421465 +-0.675937991 +-0.70524419 +-0.73209972 +-0.756340074 +-0.777766122 +-0.79641247 +-0.812228622 +-0.825179269 +-0.835087596 +-0.842013548 +-0.845933126 +-0.846816754 +-0.844648392 +-0.839465795 +-0.831288171 +-0.820056196 +-0.805930569 +-0.788943791 +-0.769144304 +-0.746456287 +-0.721173993 +-0.693360429 +-0.663076486 +-0.630230356 +-0.59524061 +-0.558192894 +-0.519157116 +-0.478015622 +-0.435329812 +-0.39116324 +-0.345603011 +-0.298489842 +-0.25056189 +-0.201792505 +-0.152301817 +-0.101873087 +-0.0514539375 +-0.000854379545 +0.0498155881 +0.100595556 +0.150681438 +0.200240027 +0.249238707 +0.297458136 +0.344380079 +0.39009104 +0.434648082 +0.477571612 +0.518676176 +0.557955954 +0.595540555 +0.630753534 +0.663721274 +0.694414052 +0.722755533 +0.748362168 +0.771337553 +0.791693936 +0.809191139 +0.823779887 +0.835477039 +0.844281845 +0.850023466 +0.852780349 +0.852529644 +0.849244985 +0.842980991 +0.833759404 +0.821484871 +0.806399355 +0.788490649 +0.767719085 +0.744207871 +0.718185074 +0.689640477 +0.658389551 +0.625082285 +0.589585806 +0.551810494 +0.512141142 +0.470815845 +0.427758636 +0.382944661 +0.337101781 +0.290077716 +0.241655691 +0.19267729 +0.143092526 +0.092764511 +0.0421090523 +-0.00846860084 +-0.0591184063 +-0.109848068 +-0.159821629 +-0.209244947 +-0.258366298 +-0.306195118 +-0.352930032 +-0.398728875 +-0.442980509 +-0.485556323 +-0.52662086 +-0.565876846 +-0.602955815 +-0.638027537 +-0.67102542 +-0.701444518 +-0.729455458 +-0.755130105 +-0.777937177 +-0.798054991 +-0.815545913 +-0.830042871 +-0.841658269 +-0.850410966 +-0.856138546 +-0.858891911 +-0.858657342 +-0.855418272 +-0.849228094 +-0.840033498 +-0.827916752 +-0.812981541 +-0.795128558 +-0.774506467 +-0.751297903 +-0.725352522 +-0.696868623 +-0.666116184 +-0.632890879 +-0.597438918 +-0.560106516 +-0.520635109 +-0.479329923 +-0.436585293 +-0.392091331 +-0.346232569 +-0.299410403 +-0.251269992 +-0.202299912 +-0.152859918 +-0.102560112 +-0.0520168469 +-0.00149804667 +0.0494079606 +0.0999401055 +0.149967391 +0.199906986 +0.248848552 +0.296831536 +0.344259928 +0.390086965 +0.434557232 +0.477966437 +0.519277845 +0.558901902 +0.596855722 +0.632422885 +0.665963336 +0.697300399 +0.726025974 +0.752427208 +0.776200517 +0.797200286 +0.815620497 +0.831126523 +0.843756192 +0.853593159 +0.86039286 +0.864269293 +0.865175307 +0.863108365 +0.858072112 +0.850062633 +0.839202005 +0.825359056 +0.808738265 +0.78942325 +0.767147293 +0.742487768 +0.715220374 +0.685336507 +0.65336204 +0.618923334 +0.582419791 +0.544112545 +0.503509756 +0.461566322 +0.417975029 +0.372669244 +0.326495616 +0.278872096 +0.230389536 +0.181358259 +0.131130515 +0.0809943143 +0.0304048466 +-0.0205032842 +-0.0709362888 +-0.121574827 +-0.171534988 +-0.22082283 +-0.269815027 +-0.317372165 +-0.364168286 +-0.4096833 +-0.453560009 +-0.496406384 +-0.537083659 +-0.576129213 +-0.613303302 +-0.64813401 +-0.681121855 +-0.711508701 +-0.739557054 +-0.765208388 +-0.788059094 +-0.808450894 +-0.82594898 +-0.840675676 +-0.852613623 +-0.861567801 +-0.867675864 +-0.870796622 +-0.870984173 +-0.868198623 +-0.86251479 +-0.853834294 +-0.842326063 +-0.827958878 +-0.810705084 +-0.790874668 +-0.768121217 +-0.74298712 +-0.715249712 +-0.685021578 +-0.652722887 +-0.617772178 +-0.581177695 +-0.542356844 +-0.501751623 +-0.459623456 +-0.415520348 +-0.37051843 +-0.323817402 +-0.276304514 +-0.22781794 +-0.178335916 +-0.128693213 +-0.0779728994 +-0.0275880538 +0.0232443285 +0.0739134301 +0.124178504 +0.174443405 +0.223584902 +0.272539622 +0.320136854 +0.366876781 +0.412402005 +0.456325798 +0.499140486 +0.539791905 +0.579085637 +0.616104742 +0.651219259 +0.68415656 +0.714662529 +0.743035933 +0.768612235 +0.79191164 +0.812327559 +0.830152124 +0.845157304 +0.857316334 +0.866664514 +0.873043524 +0.876564082 +0.877116104 +0.874736111 +0.869446465 +0.861243264 +0.850140542 +0.836267167 +0.819459757 +0.800127501 +0.777832108 +0.753238092 +0.725885777 +0.696277043 +0.664264763 +0.630007501 +0.593790196 +0.555316174 +0.515400429 +0.473201345 +0.430022865 +0.384875019 +0.338873675 +0.291434519 +0.243190212 +0.194099117 +0.144247254 +0.0941609867 +0.0433619207 +-0.00705393798 +-0.0581238924 +-0.108292447 +-0.158772499 +-0.208158006 +-0.257302198 +-0.305282312 +-0.352451213 +-0.398377216 +-0.44296058 +-0.486209045 +-0.527633467 +-0.567614892 +-0.605350941 +-0.641517926 +-0.67509586 +-0.706932371 +-0.735980697 +-0.762961944 +-0.787139568 +-0.808931149 +-0.827898724 +-0.844234883 +-0.857722435 +-0.868409118 +-0.876219891 +-0.881136889 +-0.883150171 +-0.882252313 +-0.878425227 +-0.871742621 +-0.862110839 +-0.849748175 +-0.834425547 +-0.816560454 +-0.79573757 +-0.772617976 +-0.746559844 +-0.718469246 +-0.687574207 +-0.654852936 +-0.619534706 +-0.582608681 +-0.543336861 +-0.502688856 +-0.4599828 +-0.416145908 +-0.370567987 +-0.324118404 +-0.27626675 +-0.227815959 +-0.178316794 +-0.128503277 +-0.0780029088 +-0.0274834837 +0.0233599234 +0.0739190004 +0.124443783 +0.174375843 +0.223925217 +0.272572198 +0.320502555 +0.367223892 +0.412912921 +0.457094184 +0.499948701 +0.541009865 +0.580473277 +0.617876502 +0.653435797 +0.686692624 +0.717884812 +0.746562665 +0.772980592 +0.7967085 +0.818005961 +0.836479434 +0.852375523 +0.865360501 +0.875643153 +0.882978987 +0.887507661 +0.889109082 +0.887816562 +0.883674622 +0.876567899 +0.866740462 +0.853919514 +0.838523312 +0.820174945 +0.799394646 +0.775773392 +0.749865066 +0.721294464 +0.690579989 +0.657447994 +0.62231112 +0.585064647 +0.545946299 +0.50508499 +0.462477851 +0.418547157 +0.372989605 +0.326573271 +0.278642742 +0.230354814 +0.180660665 +0.13109543 +0.0803547744 +0.0300544259 +-0.0209516872 +-0.0714014218 +-0.122008913 +-0.171959417 +-0.221512838 +-0.270319313 +-0.318180561 +-0.365210107 +-0.410766856 +-0.455406428 +-0.498080158 +-0.539744313 +-0.579073686 +-0.617060307 +-0.652641079 +-0.68642413 +-0.71780714 +-0.746973935 +-0.773733185 +-0.797934355 +-0.819700157 +-0.838653875 +-0.855117755 +-0.868629347 +-0.879515562 +-0.887454923 +-0.89260628 +-0.894863518 +-0.894252806 +-0.890762048 +-0.884437816 +-0.875205463 +-0.863290774 +-0.848395873 +-0.831012434 +-0.810753414 +-0.788051834 +-0.762730931 +-0.734962654 +-0.704945702 +-0.672428066 +-0.6381311 +-0.601260074 +-0.562995412 +-0.52252052 +-0.480623931 +-0.437096067 +-0.392073369 +-0.346078334 +-0.298478853 +-0.250521056 +-0.201147492 +-0.151632227 +-0.101335924 +-0.0507790086 +-0.00021385129 +0.0507487807 +0.100991682 +0.151593766 +0.201107073 +0.25035479 +0.29867799 +0.345953853 +0.392459445 +0.43723179 +0.481202027 +0.523125763 +0.563680933 +0.602368401 +0.63902574 +0.673951107 +0.706354359 +0.736893195 +0.764802593 +0.790409016 +0.8135253 +0.833927434 +0.851904469 +0.866956432 +0.879398982 +0.888984801 +0.89575858 +0.899714763 +0.900797333 +0.899015465 +0.894406867 +0.886946616 +0.876654568 +0.863680579 +0.847768056 +0.829393312 +0.808237132 +0.78456861 +0.758516923 +0.72978314 +0.699088091 +0.665875587 +0.630727155 +0.59363156 +0.554359605 +0.513759148 +0.471098609 +0.427241246 +0.382022037 +0.335296154 +0.287979354 +0.239235576 +0.190100041 +0.140326305 +0.0897943442 +0.0394726475 +-0.0115067951 +-0.0620925143 +-0.112493158 +-0.162898003 +-0.212282654 +-0.261479791 +-0.309581319 +-0.356641267 +-0.402998737 +-0.447582881 +-0.491134372 +-0.533008574 +-0.5730406 +-0.611739684 +-0.648040159 +-0.682548048 +-0.714925609 +-0.744856511 +-0.772792188 +-0.798015214 +-0.820817832 +-0.841150177 +-0.858675013 +-0.87366247 +-0.885830497 +-0.895211484 +-0.90186406 +-0.905620742 +-0.906570904 +-0.904670091 +-0.899970845 +-0.892384631 +-0.882067251 +-0.869010518 +-0.853097785 +-0.83469613 +-0.813562584 +-0.789878183 +-0.76389149 +-0.735214747 +-0.704486367 +-0.671574116 +-0.636248181 +-0.599320591 +-0.560303205 +-0.519483133 +-0.477330811 +-0.433269878 +-0.388132703 +-0.341915815 +-0.294063348 +-0.245875123 +-0.196734571 +-0.146722346 +-0.0966904335 +-0.0459975613 +0.00477277066 +0.0552511681 +0.106073312 +0.156189755 +0.205725098 +0.255204658 +0.303302173 +0.350619635 +0.397141874 +0.442007295 +0.485762109 +0.528056258 +0.5684403 +0.607383994 +0.64430249 +0.679081614 +0.712098329 +0.742646905 +0.770854416 +0.796993422 +0.820356892 +0.84124095 +0.859681739 +0.875276175 +0.88823057 +0.898486531 +0.90588391 +0.910522648 +0.912339409 +0.911336002 +0.907508367 +0.900862165 +0.891487547 +0.87928266 +0.864379904 +0.846895815 +0.826640237 +0.803910979 +0.778803754 +0.751052198 +0.721137736 +0.689104521 +0.654623954 +0.618358914 +0.580288077 +0.540035687 +0.498425077 +0.45537136 +0.410467048 +0.364658921 +0.317814037 +0.269508243 +0.220762676 +0.171422181 +0.121059994 +0.070715229 +0.0202425874 +-0.0307747972 +-0.0813381874 +-0.131549343 +-0.181804686 +-0.231200659 +-0.279765024 +-0.327865456 +-0.374739434 +-0.420318227 +-0.464934825 +-0.507999757 +-0.549337548 +-0.589242934 +-0.627313545 +-0.663272724 +-0.697375588 +-0.729399943 +-0.758991872 +-0.786367436 +-0.811455008 +-0.833867012 +-0.853782557 +-0.871228077 +-0.885845543 +-0.897784127 +-0.907078939 +-0.913505758 +-0.917166633 +-0.918038934 +-0.916094915 +-0.911379406 +-0.903844761 +-0.893548857 +-0.880588224 +-0.864896793 +-0.846492718 +-0.825644224 +-0.802272216 +-0.77622272 +-0.748059525 +-0.717635707 +-0.684728158 +-0.649964791 +-0.613295744 +-0.574532888 +-0.534049971 +-0.492140745 +-0.448625048 +-0.403489866 +-0.357488019 +-0.310403717 +-0.261898663 +-0.213020633 +-0.163537583 +-0.113250233 +-0.0626862697 +-0.0121567178 +0.0385231159 +0.0894109171 +0.139607276 +0.189390166 +0.239023483 +0.28761617 +0.335251414 +0.382073547 +0.427837878 +0.47202732 +0.514805138 +0.556437711 +0.595996525 +0.633753278 +0.66978743 +0.703789568 +0.73549851 +0.76500936 +0.792479936 +0.817279718 +0.839633211 +0.859562632 +0.87688073 +0.891474115 +0.903399682 +0.912686727 +0.919128184 +0.922816598 +0.923736518 +0.921852225 +0.917205312 +0.909814646 +0.899597317 +0.886725352 +0.871219153 +0.853063229 +0.83220967 +0.809010284 +0.783391643 +0.755258392 +0.72487885 +0.692449375 +0.657949051 +0.62113895 +0.582746267 +0.542642786 +0.50082428 +0.457252785 +0.412632424 +0.36677673 +0.319592621 +0.271433185 +0.222689503 +0.173276525 +0.122981885 +0.0725446649 +0.0220088988 +-0.0285986966 +-0.079589267 +-0.129901641 +-0.179815088 +-0.229269264 +-0.278362275 +-0.326235457 +-0.373144415 +-0.419078832 +-0.463919878 +-0.507089206 +-0.548757305 +-0.588955132 +-0.627434981 +-0.663844169 +-0.698287164 +-0.730808654 +-0.761122821 +-0.78903974 +-0.814619557 +-0.837897471 +-0.858627885 +-0.87672642 +-0.89222849 +-0.90514484 +-0.915323566 +-0.922745951 +-0.92743619 +-0.929376494 +-0.92852878 +-0.924925512 +-0.918584331 +-0.909466705 +-0.897631554 +-0.883177056 +-0.866108847 +-0.846386576 +-0.824114032 +-0.799497421 +-0.772515152 +-0.743152713 +-0.711478072 +-0.677869539 +-0.642255279 +-0.604679142 +-0.565075321 +-0.524069799 +-0.48151312 +-0.437530478 +-0.391859583 +-0.345391016 +-0.297908264 +-0.249541439 +-0.200120522 +-0.150294421 +-0.10013274 +-0.0496701393 +0.00113755476 +0.0519926198 +0.102461913 +0.152635343 +0.202414553 +0.251913939 +0.300307575 +0.34782313 +0.394321365 +0.439939355 +0.484071435 +0.52668838 +0.567762281 +0.607273447 +0.645095523 +0.68080648 +0.714521933 +0.746143309 +0.775768427 +0.802928262 +0.827699812 +0.85004553 +0.869947595 +0.887318778 +0.901983577 +0.914005278 +0.923348896 +0.930011762 +0.933895585 +0.935031412 +0.93342823 +0.929082464 +0.921952531 +0.912152601 +0.89968147 +0.884575687 +0.866804108 +0.846458794 +0.823708493 +0.798546623 +0.771046683 +0.741104772 +0.709086593 +0.675051633 +0.639040353 +0.601157767 +0.561211881 +0.519888191 +0.477055142 +0.432824534 +0.387286587 +0.340328456 +0.292680582 +0.244173826 +0.19494933 +0.14507544 +0.0945434743 +0.044030046 +-0.00661712636 +-0.0572508433 +-0.10780724 +-0.158256502 +-0.207960019 +-0.257063323 +-0.305423868 +-0.35296335 +-0.399687091 +-0.444968972 +-0.488961198 +-0.531536218 +-0.572591008 +-0.612215796 +-0.649790156 +-0.685479877 +-0.719181623 +-0.75079783 +-0.780409025 +-0.807576791 +-0.832378974 +-0.854767246 +-0.874676917 +-0.892115991 +-0.906912555 +-0.919034485 +-0.928491937 +-0.93525771 +-0.939315096 +-0.940630068 +-0.939199306 +-0.935046614 +-0.928184171 +-0.918631973 +-0.906329727 +-0.891444507 +-0.873987331 +-0.853998217 +-0.831535049 +-0.806595446 +-0.779250885 +-0.749755511 +-0.718088623 +-0.684341736 +-0.648612335 +-0.610802073 +-0.571345461 +-0.530290304 +-0.487698737 +-0.443693628 +-0.398375989 +-0.351644716 +-0.304164407 +-0.255801303 +-0.206694748 +-0.156986194 +-0.106722233 +-0.0560125265 +-0.00536237577 +0.0453084783 +0.095854252 +0.146129553 +0.196116422 +0.245595791 +0.294186152 +0.341934287 +0.388703022 +0.434358022 +0.478876773 +0.522059427 +0.563581037 +0.603485587 +0.641658616 +0.677990651 +0.712434969 +0.744900781 +0.775080674 +0.803036295 +0.828687618 +0.851961231 +0.872796531 +0.891209562 +0.90694838 +0.920085339 +0.930582984 +0.938411417 +0.943548382 +0.945978339 +0.945670013 +0.94264568 +0.936918559 +0.928505227 +0.91742993 +0.903707236 +0.887318257 +0.868450724 +0.847094269 +0.823310126 +0.797166441 +0.768738079 +0.738008101 +0.705158948 +0.6703695 +0.633659193 +0.595132984 +0.554900981 +0.513078131 +0.469605227 +0.424886535 +0.37901382 +0.332053794 +0.284140459 +0.235410498 +0.186002892 +0.135854192 +0.0854485536 +0.0348590988 +-0.01583494 +-0.0664891576 +-0.116959296 +-0.167101652 +-0.216928996 +-0.266083143 +-0.3143814 +-0.361788791 +-0.408170507 +-0.453394688 +-0.497332791 +-0.539914574 +-0.581053548 +-0.620382517 +-0.657950071 +-0.693649594 +-0.727379795 +-0.759044996 +-0.7885554 +-0.815914898 +-0.840887289 +-0.863432819 +-0.883527275 +-0.901113819 +-0.916142735 +-0.928571564 +-0.938365225 +-0.945516121 +-0.949941362 +-0.951668817 +-0.95069635 +-0.947026915 +-0.940671102 +-0.931647098 +-0.919980637 +-0.905634734 +-0.88876066 +-0.869373578 +-0.847521563 +-0.823266632 +-0.796677583 +-0.76782979 +-0.736804995 +-0.703597261 +-0.668410459 +-0.631390278 +-0.5925803 +-0.552090327 +-0.51003488 +-0.466532865 +-0.421707247 +-0.375684695 +-0.328388956 +-0.28035678 +-0.231530829 +-0.182046149 +-0.1320424 +-0.0816606715 +-0.0310430843 +0.0196676099 +0.0703378572 +0.121006677 +0.171135131 +0.220785759 +0.269818718 +0.31809594 +0.365481514 +0.411842072 +0.457047163 +0.500969615 +0.543605487 +0.584629743 +0.623964625 +0.661546834 +0.697270813 +0.731036252 +0.762748368 +0.792318167 +0.819662696 +0.844705269 +0.867451759 +0.887669456 +0.905392276 +0.920572739 +0.933168428 +0.943144186 +0.950472214 +0.955132145 +0.957111095 +0.956403703 +0.952995867 +0.946907523 +0.93816557 +0.926791421 +0.912817164 +0.89628216 +0.87723293 +0.855723023 +0.831812862 +0.805569572 +0.777066792 +0.746279792 +0.713482718 +0.678693212 +0.642000595 +0.603507655 +0.563322185 +0.52155668 +0.478328025 +0.433757163 +0.387968756 +0.341090837 +0.293185781 +0.244432293 +0.195079839 +0.145177752 +0.0948653889 +0.0442832119 +-0.00642759692 +-0.0571255325 +-0.107669161 +-0.157917513 +-0.207730477 +-0.25696919 +-0.305514395 +-0.353317897 +-0.400011466 +-0.4455944 +-0.489939812 +-0.532924291 +-0.574428246 +-0.614336235 +-0.652537289 +-0.688925214 +-0.723398886 +-0.755862531 +-0.786225989 +-0.81440496 +-0.840373586 +-0.863956501 +-0.885124325 +-0.903833185 +-0.9200313 +-0.933673873 +-0.944723216 +-0.953148851 +-0.958927591 +-0.962043602 +-0.962488443 +-0.960261086 +-0.955367918 +-0.947822717 +-0.9376417 +-0.924828549 +-0.909470906 +-0.891589641 +-0.871234536 +-0.848462212 +-0.823335973 +-0.795925627 +-0.766307288 +-0.734563166 +-0.700781334 +-0.665055483 +-0.627484661 +-0.588172995 +-0.547229402 +-0.504767287 +-0.460904225 +-0.415688093 +-0.36935853 +-0.322031971 +-0.273810698 +-0.22482805 +-0.175219433 +-0.125121949 +-0.0746740131 +-0.0240149729 +0.026715277 +0.0773766813 +0.127829411 +0.177934248 +0.22755297 +0.27654873 +0.324786436 +0.372133119 +0.418458299 +0.463634348 +0.507586496 +0.550119348 +0.591109105 +0.630474071 +0.66810597 +0.703901326 +0.737761745 +0.769594184 +0.799311206 +0.826831217 +0.852078689 +0.874984361 +0.895485433 +0.913525732 +0.929055865 +0.94203335 +0.952422732 +0.960195676 +0.965331042 +0.96781494 +0.967640767 +0.964809219 +0.959328285 +0.951213227 +0.940468019 +0.927151841 +0.91129121 +0.892929357 +0.872116855 +0.848910985 +0.823375573 +0.795580811 +0.765603066 +0.733524665 +0.699433666 +0.663423619 +0.625593302 +0.58604645 +0.544891472 +0.502241147 +0.458212318 +0.412925569 +0.366504891 +0.319077346 +0.270772714 +0.221723141 +0.172062773 +0.121927389 +0.0714540323 +0.0207806331 +-0.0299543692 +-0.0806124027 +-0.131055142 +-0.181144888 +-0.230744938 +-0.279719965 +-0.327936381 +-0.375262704 +-0.421569915 +-0.466763943 +-0.510657623 +-0.553160052 +-0.59415864 +-0.633541798 +-0.671202367 +-0.707037909 +-0.740950986 +-0.77284942 +-0.802646543 +-0.83026143 +-0.855619119 +-0.878650808 +-0.899294044 +-0.917492886 +-0.933198057 +-0.946367075 +-0.956964362 +-0.964961344 +-0.97033652 +-0.973075517 +-0.973171131 +-0.970623339 +-0.965439297 +-0.957633318 +-0.947226828 +-0.934248307 +-0.918733208 +-0.900723856 +-0.880269333 +-0.857425337 +-0.832254033 +-0.804823881 +-0.775209444 +-0.743491184 +-0.709755246 +-0.674093216 +-0.636601873 +-0.597382926 +-0.556542733 +-0.514192013 +-0.470445544 +-0.425421852 +-0.379242884 +-0.332033681 +-0.283922037 +-0.235038151 +-0.185514276 +-0.135484358 +-0.0850836733 +-0.0344484656 +0.0162844267 +0.0669779382 +0.117495148 +0.167699647 +0.21745591 +0.266629659 +0.315088224 +0.362700901 +0.409339307 +0.454877719 +0.499193418 +0.542167015 +0.583682773 +0.623628916 +0.661897929 +0.698386847 +0.732997529 +0.76563692 +0.796217299 +0.824656516 +0.850878205 +0.874811992 +0.896393679 +0.915565415 +0.932275848 +0.946480259 +0.958140682 +0.967226001 +0.973712032 +0.977581582 +0.978824495 +0.977437673 +0.973425086 +0.966797752 +0.957573708 +0.945777956 +0.931442397 +0.914605737 +0.895297585 +0.873595419 +0.849549773 +0.823223576 +0.794687642 +0.764018686 +0.731299121 +0.696616833 +0.660064941 +0.621741546 +0.581749466 +0.540195961 +0.497192438 +0.452854156 +0.407299914 +0.360651731 +0.313034517 +0.26457574 +0.215405082 +0.165654093 +0.115455836 +0.0649445316 +0.0142552006 +-0.0364767001 +-0.0871156375 +-0.137526365 +-0.187574285 +-0.237125805 +-0.286048696 +-0.334212444 +-0.381488596 +-0.427751106 +-0.472876664 +-0.516745029 +-0.559239346 +-0.600263722 +-0.63971208 +-0.677416815 +-0.713319445 +-0.747324499 +-0.779341588 +-0.809285643 +-0.83707714 +-0.862642307 +-0.885913318 +-0.906828473 +-0.925332355 +-0.94137598 +-0.954916917 +-0.965919405 +-0.974354439 +-0.980199848 +-0.983440347 +-0.984067578 +-0.982080126 +-0.977483521 +-0.970290218 +-0.960519565 +-0.948197743 +-0.933354066 +-0.916000671 +-0.896239992 +-0.874099719 +-0.84963882 +-0.822922402 +-0.794021528 +-0.763013035 +-0.729979319 +-0.695008118 +-0.658192279 +-0.619629504 +-0.579422095 +-0.537676676 +-0.494503912 +-0.450018213 +-0.40433743 +-0.35758254 +-0.309877329 +-0.261348056 +-0.212068456 +-0.16221782 +-0.111991483 +-0.0614650545 +-0.0107720808 +0.0399534896 +0.0905776623 +0.14096675 +0.190987726 +0.240508574 +0.289398635 +0.337528955 +0.384772619 +0.431005088 +0.476104528 +0.519952123 +0.562432394 +0.603485702 +0.642942777 +0.680657141 +0.716580645 +0.750618851 +0.782682316 +0.81268682 +0.840553587 +0.866209491 +0.889587241 +0.910625561 +0.929269341 +0.945469785 +0.959184534 +0.970377773 +0.979026142 +0.985096981 +0.988562427 +0.989429946 +0.987697541 +0.983370038 +0.976459077 +0.96698307 +0.954967156 +0.940443127 +0.923449344 +0.904030633 +0.882238161 +0.858129304 +0.831725275 +0.803123158 +0.77245575 +0.739760949 +0.705124629 +0.668637724 +0.630395982 +0.590499717 +0.54905354 +0.506166085 +0.461949724 +0.416520272 +0.369996677 +0.32239841 +0.273990494 +0.224920156 +0.175257832 +0.125133374 +0.0746778024 +0.0240229614 +-0.0266988242 +-0.0773550948 +-0.127813602 +-0.177942651 +-0.227611449 +-0.276795441 +-0.325219424 +-0.372730282 +-0.419272038 +-0.464723443 +-0.508966125 +-0.551884898 +-0.593368057 +-0.633307673 +-0.671599861 +-0.708145061 +-0.742880879 +-0.775733134 +-0.806471258 +-0.835111285 +-0.861578926 +-0.885805566 +-0.907728435 +-0.927290768 +-0.94444195 +-0.959137644 +-0.971339906 +-0.98103106 +-0.988157522 +-0.992696122 +-0.99465486 +-0.99402894 +-0.990820276 +-0.985037475 +-0.97669582 +-0.965817221 +-0.952430157 +-0.936553724 +-0.918188578 +-0.897491267 +-0.874463956 +-0.849166592 +-0.821664979 +-0.792030608 +-0.760340466 +-0.726676834 +-0.691127075 +-0.65372326 +-0.614563601 +-0.573913119 +-0.531773419 +-0.488253676 +-0.443466601 +-0.397528138 +-0.350557173 +-0.30267522 +-0.254006107 +-0.20447786 +-0.15458239 +-0.104310187 +-0.0537646585 +-0.00307633525 +0.0476239248 +0.0982052736 +0.14853721 +0.198489917 +0.248103569 +0.296965998 +0.345005801 +0.392158713 +0.438303305 +0.48332078 +0.527095282 +0.569514187 +0.610468392 +0.650017284 +0.687731476 +0.723657968 +0.757722553 +0.789837799 +0.819921312 +0.84789594 +0.873689973 +0.89727339 +0.918567385 +0.937421898 +0.953865975 +0.967857654 +0.979361279 +0.988347583 +0.994793766 +0.99868372 +1 +0.998727213 +0.994888595 +0.988494299 +0.979561019 +0.968111945 +0.954176699 +0.937791256 +0.918892489 +0.897707961 +0.874225196 +0.848498548 +0.820594155 +0.7905837 +0.758544224 +0.724546134 +0.688506704 +0.650873614 +0.611570737 +0.570698775 +0.528362409 +0.484670018 +0.43973341 +0.393569042 +0.346320444 +0.298342539 +0.249598231 +0.200212069 +0.150310193 +0.100020019 +0.04946991 +0.04946991 + +shape_id 7 +num_samples 2 +1 +0 + +shape_id 8 +num_samples 2 +0 +143 + + +[SIGNATURE] +# This is the hash of the Pulseq file, calculated right before the [SIGNATURE] section was added +# It can be reproduced/verified with md5sum if the file trimmed to the position right above [SIGNATURE] +# The new line character preceding [SIGNATURE] BELONGS to the signature (and needs to be sripped away for recalculating/verification) +Type md5 +Hash 0e6208a255f0240451fc393808fedc04 diff --git a/KomaMRIPlots/src/ui/DisplayFunctions.jl b/KomaMRIPlots/src/ui/DisplayFunctions.jl index f9fa79b0f..24af5a492 100644 --- a/KomaMRIPlots/src/ui/DisplayFunctions.jl +++ b/KomaMRIPlots/src/ui/DisplayFunctions.jl @@ -33,18 +33,6 @@ end function generate_seq_time_layout_config(title, width, height, range, slider, show_seq_blocks, darkmode; T0) #LAYOUT bgcolor, text_color, plot_bgcolor, grid_color, sep_color = theme_chooser(darkmode) - #Shapes - shapes = [] - N = length(T0) - if show_seq_blocks - aux = [line( - xref="x", yref="paper", - x0=T0[i]*1e3, y0=0, - x1=T0[i]*1e3, y1=1, - line=attr(color=sep_color, width=2), - ) for i = 1:N] - append!(shapes, aux) - end l = Layout(;title=title, hovermode="closest", xaxis_title="", modebar=attr(orientation="h", yanchor="bottom", xanchor="right", y=1, x=0, bgcolor=bgcolor, color=text_color, activecolor=plot_bgcolor), @@ -58,6 +46,8 @@ function generate_seq_time_layout_config(title, width, height, range, slider, sh font_color=text_color, yaxis_fixedrange = false, xaxis=attr( + # tickmode= show_seq_blocks ? "array" : "linear", + # tickvals=T0*1e3, ticksuffix=" ms", domain=range[:], range=range[:], @@ -72,7 +62,6 @@ function generate_seq_time_layout_config(title, width, height, range, slider, sh ] ), ), - shapes = shapes, margin=attr(t=0,l=0,r=0,b=0) ) if height !== nothing @@ -139,7 +128,10 @@ Plots a sequence struct. - `darkmode`: (`::Bool`, `=false`) boolean to indicate whether to display darkmode style - `range`: (`::Vector{Real}`, `=[]`) time range to be displayed initially - `title`: (`::String`, `=""`) plot title +- `freq_in_phase`: (`::Bool`, `=true`) Include FM modulation in RF phase +- `gl`: (`::Bool`, `=false`) use `PlotlyJS.scattergl` backend (faster) - `max_rf_samples`: (`::Integer`, `=100`) maximum number of RF samples +- `show_adc`: (`::Bool`, `=false`) plot ADC samples with markers # Returns - `p`: (`::PlotlyJS.SyncPlot`) plot of the Sequence struct @@ -160,43 +152,69 @@ function plot_seq( slider=false, show_seq_blocks=false, darkmode=false, - max_rf_samples=Inf, range=[], title="", xaxis="x", yaxis="y", - showlegend=true + showlegend=true, + freq_in_phase=false, + # Performance related + gl=false, + max_rf_samples=100, + show_adc=false ) + # Aux functions + scatter_fun = gl ? scattergl : scatter + usrf(x) = length(x) > max_rf_samples ? ([@view x[1]; @view x[2:(length(x)÷max_rf_samples):end-1]; @view x[end]]) : x + usadc(x) = show_adc || isempty(x) ? x : [first(x); last(x)] # Get the samples of the events in the sequence - samples = get_samples(seq; off_val=Inf, max_rf_samples) + seq_samples = (get_samples(seq, i; freq_in_phase) for i in 1:length(seq)) + gx = (A=reduce(vcat, [block.gx.A; Inf] for block in seq_samples), + t=reduce(vcat, [block.gx.t; Inf] for block in seq_samples)) + gy = (A=reduce(vcat, [block.gy.A; Inf] for block in seq_samples), + t=reduce(vcat, [block.gy.t; Inf] for block in seq_samples)) + gz = (A=reduce(vcat, [block.gz.A; Inf] for block in seq_samples), + t=reduce(vcat, [block.gz.t; Inf] for block in seq_samples)) + rf = (A=reduce(vcat, [usrf(block.rf.A); Inf] for block in seq_samples), + t=reduce(vcat, [usrf(block.rf.t); Inf] for block in seq_samples)) + Δf = (A=reduce(vcat, [usrf(block.Δf.A); Inf] for block in seq_samples), + t=reduce(vcat, [usrf(block.Δf.t); Inf] for block in seq_samples)) + adc = (A=reduce(vcat, [usadc(block.adc.A); Inf] for block in seq_samples), + t=reduce(vcat, [usadc(block.adc.t); Inf] for block in seq_samples)) # Define general params and the vector of plots idx = ["Gx" "Gy" "Gz"] O = size(seq.RF, 1) - p = [scatter() for _ in 1:(3 + 2O + 1)] + p = [scatter_fun() for _ in 1:(3 + 3O + 1)] # For GRADs - p[1] = scatter(x=samples.gx.t*1e3, y=samples.gx.A*1e3, name=idx[1], hovertemplate="(%{x:.4f} ms, %{y:.2f} mT/m)", + p[1] = scatter(x=gx.t*1e3, y=gx.A*1e3, name=idx[1], hovertemplate="(%{x:.4f} ms, %{y:.2f} mT/m)", xaxis=xaxis, yaxis=yaxis, legendgroup="Gx", showlegend=showlegend, marker=attr(color="#636EFA")) - p[2] = scatter(x=samples.gy.t*1e3, y=samples.gy.A*1e3, name=idx[2], hovertemplate="(%{x:.4f} ms, %{y:.2f} mT/m)", + p[2] = scatter(x=gy.t*1e3, y=gy.A*1e3, name=idx[2], hovertemplate="(%{x:.4f} ms, %{y:.2f} mT/m)", xaxis=xaxis, yaxis=yaxis, legendgroup="Gy", showlegend=showlegend, marker=attr(color="#EF553B")) - p[3] = scatter(x=samples.gz.t*1e3, y=samples.gz.A*1e3, name=idx[3], hovertemplate="(%{x:.4f} ms, %{y:.2f} mT/m)", + p[3] = scatter(x=gz.t*1e3, y=gz.A*1e3, name=idx[3], hovertemplate="(%{x:.4f} ms, %{y:.2f} mT/m)", xaxis=xaxis, yaxis=yaxis, legendgroup="Gz", showlegend=showlegend, marker=attr(color="#00CC96")) # For RFs for j in 1:O - rf_phase = angle.(samples.rf.A[:,j]) - rf_phase[samples.rf.A[:,j] .== Inf] .= Inf - p[2j-1+3] = scatter(x=samples.rf.t*1e3, y=abs.(samples.rf.A[:,j])*1e6, name="|B1|", hovertemplate="(%{x:.4f} ms, %{y:.2f} μT)", - xaxis=xaxis, yaxis=yaxis, legendgroup="|B1|", showlegend=showlegend, marker=attr(color="#AB63FA")) - p[2j+3] = scatter(x=samples.rf.t*1e3, y=rf_phase, text=ones(size(samples.rf.t)), name="∠B1", hovertemplate="(%{x:.4f} ms, ∠B1: %{y:.4f} rad)", visible="legendonly", - xaxis=xaxis, yaxis=yaxis, legendgroup="∠B1", showlegend=showlegend, marker=attr(color="#FFA15A")) + rf_amp = abs.(rf.A[:,j]) + rf_phase = angle.(rf.A[:,j]) + rf_phase[rf_amp .== Inf] .= Inf # Avoid weird jumps + # Plot RF + p[2j-1+3] = scatter_fun(x=rf.t*1e3, y=rf_amp*1e6, name="|B1|_AM", hovertemplate="(%{x:.4f} ms, %{y:.2f} μT)", + xaxis=xaxis, yaxis=yaxis, legendgroup="|B1|_AM", showlegend=showlegend, marker=attr(color="#AB63FA")) + p[2j+3] = scatter_fun(x=rf.t*1e3, y=rf_phase, text=ones(size(rf.t)), name="∠B1_AM", hovertemplate="(%{x:.4f} ms, ∠B1: %{y:.4f} rad)", visible="legendonly", + xaxis=xaxis, yaxis=yaxis, legendgroup="∠B1_AM", showlegend=showlegend, marker=attr(color="#FFA15A")) + if !freq_in_phase + p[2j+4] = scatter_fun(x=Δf.t*1e3, y=Δf.A[:,j]*1e-3, text=ones(size(Δf.t)), name="B1_FM", hovertemplate="(%{x:.4f} ms, B1_FM: %{y:.4f} kHz)", visible="legendonly", + xaxis=xaxis, yaxis=yaxis, legendgroup="B1_FM", showlegend=showlegend, marker=attr(color="#AB63FA"), line=attr(dash="dot")) + end end # For ADCs - p[2O+3+1] = scatter(x=samples.adc.t*1e3, y=samples.adc.A*1.0, name="ADC", hovertemplate="(%{x:.4f} ms, %{y:i})", - xaxis=xaxis, yaxis=yaxis, legendgroup="ADC", showlegend=showlegend, color=marker=attr(color="#19D3F3")) + p[3O+3+1] = scatter_fun(x=adc.t*1e3, y=adc.A*0, name="ADC", hovertemplate="(%{x:.4f} ms, %{y:i})", + xaxis=xaxis, yaxis=yaxis, legendgroup="ADC", showlegend=showlegend, mode=(show_adc ? "markers" : "line"), marker=attr(color="#19D3F3")) # Return the plot l, config = generate_seq_time_layout_config(title, width, height, range, slider, show_seq_blocks, darkmode; T0=get_block_start_times(seq)) @@ -842,7 +860,8 @@ function plot_signal( slider=true, show_sim_blocks=false, darkmode=false, - range=[] + range=[], + gl=false ) not_Koma = raw.params["systemVendor"] != "KomaMRI.jl" t = [] @@ -931,10 +950,11 @@ function plot_signal( if width !== nothing l.width = width end - p = [scatter() for j=1:3] + scatter_fun = gl ? scattergl : scatter + p = [scatter_fun() for j=1:3] p[1] = scatter(x=t,y=abs.(signal), name="|S(t)|",hovertemplate="(%{x:.4f} ms, %{y:.3f} a.u.)") - p[2] = scatter(x=t,y=real.(signal),name="Re{S(t)}",hovertemplate="(%{x:.4f} ms, %{y:.3f} a.u.)") - p[3] = scatter(x=t,y=imag.(signal),name="Im{S(t)}",hovertemplate="(%{x:.4f} ms, %{y:.3f} a.u.)") + p[2] = scatter_fun(x=t,y=real.(signal),name="Re{S(t)}",hovertemplate="(%{x:.4f} ms, %{y:.3f} a.u.)") + p[3] = scatter_fun(x=t,y=imag.(signal),name="Im{S(t)}",hovertemplate="(%{x:.4f} ms, %{y:.3f} a.u.)") config = PlotConfig( displaylogo=false, toImageButtonOptions=attr( @@ -1009,11 +1029,12 @@ julia> plot_seqd(seq) """ function plot_seqd(seq::Sequence; sampling_params=KomaMRIBase.default_sampling_params()) seqd = KomaMRIBase.discretize(seq; sampling_params) - Gx = scatter(x=seqd.t*1e3, y=seqd.Gx*1e3, name="Gx", mode="markers+lines", marker_symbol=:circle) - Gy = scatter(x=seqd.t*1e3, y=seqd.Gy*1e3, name="Gy", mode="markers+lines", marker_symbol=:circle) - Gz = scatter(x=seqd.t*1e3, y=seqd.Gz*1e3, name="Gz", mode="markers+lines", marker_symbol=:circle) - B1_abs = scatter(x=seqd.t*1e3, y=abs.(seqd.B1*1e6), name="|B1|", mode="markers+lines", marker_symbol=:circle) - B1_angle = scatter(x=seqd.t*1e3, y=angle.(seqd.B1), name="∠B1", mode="markers+lines", marker_symbol=:circle) - ADC = scatter(x=seqd.t[seqd.ADC]*1e3, y=zeros(sum(seqd.ADC)), name="ADC", mode="markers", marker_symbol=:x) - plot_koma([Gx,Gy,Gz,B1_abs,B1_angle,ADC]) + Gx = scattergl(x=seqd.t*1e3, y=seqd.Gx*1e3, name="Gx", mode="markers+lines", marker_symbol=:circle) + Gy = scattergl(x=seqd.t*1e3, y=seqd.Gy*1e3, name="Gy", mode="markers+lines", marker_symbol=:circle) + Gz = scattergl(x=seqd.t*1e3, y=seqd.Gz*1e3, name="Gz", mode="markers+lines", marker_symbol=:circle) + B1_abs = scattergl(x=seqd.t*1e3, y=abs.(seqd.B1*1e6), name="|B1|", mode="markers+lines", marker_symbol=:circle) + B1_angle = scattergl(x=seqd.t*1e3, y=angle.(seqd.B1), name="∠B1", mode="markers+lines", marker_symbol=:circle) + ADC = scattergl(x=seqd.t[seqd.ADC]*1e3, y=zeros(sum(seqd.ADC)), name="ADC", mode="markers", marker_symbol=:x) + B1_Δf = scattergl(x=seqd.t*1e3, y=abs.(seqd.Δf*1e-3), name="B1_Δf", mode="markers+lines", marker_symbol=:circle, visible="legendonly") + plot_koma([Gx,Gy,Gz,B1_abs,B1_angle,ADC,B1_Δf]) end diff --git a/src/ui/ExportMATFunctions.jl b/src/ui/ExportMATFunctions.jl index 1eb0ce1dc..e9d6b4d23 100644 --- a/src/ui/ExportMATFunctions.jl +++ b/src/ui/ExportMATFunctions.jl @@ -1,17 +1,23 @@ function export_2_mat_sequence(seq, matfolder; matfilename="seq_sequence.mat") # Get the samples of the events in the sequence - samples = get_samples(seq; off_val=Inf, max_rf_samples=100) + samples = get_samples(seq) # Create a dictionary with the event samples of the sequence - GRADS = hcat(samples.gx.t, samples.gy.t, samples.gz.t, samples.gx.A, samples.gy.A, samples.gz.A) - RFS = hcat(samples.rf.t, samples.rf.A) + Gx = hcat(samples.gx.t, samples.gx.A) + Gy = hcat(samples.gy.t, samples.gy.A) + Gz = hcat(samples.gz.t, samples.gz.A) + RF_AM = hcat(samples.rf.t, samples.rf.A) + RF_FM = hcat(samples.Δf.t, samples.Δf.A) ADCS = hcat(samples.adc.t, samples.adc.A) - seq_dict = Dict("GRAD" => GRADS, - "RF" => RFS, - "ADC" => ADCS, - "DUR" => seq.DUR, - "DEF" => seq.DEF) + seq_dict = Dict( + "Gx" => Gx, + "Gy" => Gy, + "Gz" => Gz, + "RF_AM" => RF_AM, + "RF_FM" => RF_FM, + "ADCS" => ADCS + ) # Write to matlab file matwrite(joinpath(matfolder, matfilename), Dict("sequence" => seq_dict)) diff --git a/src/ui/ExportUIFunctions.jl b/src/ui/ExportUIFunctions.jl index 3afa48f8b..e60490552 100644 --- a/src/ui/ExportUIFunctions.jl +++ b/src/ui/ExportUIFunctions.jl @@ -250,7 +250,8 @@ function view_ui!(seq::Sequence, w::Window; type="sequence", darkmode=true) # Add loading progress and then a plot to the UI depending on type of the plot if type == "sequence" display_loading!(w, "Plotting sequence ...") - widget_plot = plot_seq(seq; darkmode, range=[0 30], slider=true) + long_seq = length(seq) > 1000 + widget_plot = plot_seq(seq; darkmode, range=[0 30], slider=!long_seq, gl=long_seq, show_adc=false) content!(w, "div#content", dom"div"(widget_plot)) @js_ w document.getElementById("content").dataset.content = "sequence" elseif type == "kspace"