Test Known Case


In [1]:
using PGFPlots

function _integrate_simpsons(f::Function, a::Real, b::Real, n::Int)
    # integrate using Composite Simpson's rule
    # reference: https://en.wikipedia.org/wiki/Simpson%27s_rule

    @assert(n > 0) # number of intervals
    @assert(mod(n,2) == 0) # n must be even

    h = (b-a)/n
    retval = f(a) + f(b)
    flip = true
    for i = 1 : n-1
        retval += f(a+i*h) * (flip ? 4 : 2)
        flip = !flip
    end
    return h/3*retval
end


Out[1]:
_integrate_simpsons (generic function with 1 method)

In [2]:
function Ptilde_ϕ(ϕ::Float64)
    ϕ = clamp(ϕ, -1.0, 1.0)
    f = [ϕ^2, ϕ^4]
    θ = [-1.0, -8.6]
    exp(dot(θ, f))
end

domain = (-0.82, 0.82)
Z = _integrate_simpsons(Ptilde_ϕ, domain..., 100)
p_ϕ = PGFPlots.Plots.Linear(x->Ptilde_ϕ(x)/Z, domain, style="mark=none")
Axis(p_ϕ, xmin=domain[1], xmax=domain[2], ymin=0.0, title=L"\phi")


Out[2]:

In [3]:
function Ptilde_t(t::Float64)
    t = clamp(t, -1.0, 1.0)
    f = [t^2, t^4]
    θ = [-1.0, -8.6]
    exp(dot(θ, f))
end

domain = (-1.7, 1.7)
p_t = PGFPlots.Plots.Linear(x->Ptilde_t(x)/Z, domain, style="mark=none")
Z = _integrate_simpsons(Ptilde_t, domain..., 100)
Axis(p_t, xmin=domain[1], xmax=domain[2], ymin=0.0, title=L"t")


Out[3]:

In [4]:
using Interact

w1 = -1.5
w2 = -10.0
w3 = -2.5
w4 = -10.0
# @manipulate for w1 in linspace(-10.0,10.0,41),
#                 w2 in linspace(-10.0,10.0,41),
#                 w3 in linspace(-10.0,10.0,41),
#                 w4 in linspace(-10.0,10.0,41)
    
function Ptilde_v(v::Float64)
    μ, σ = 13.0, 32.0-13.0
    v = (v - μ)/σ
    v = clamp(v, -1.0, 1.0)
    
    f = [v, v^2, v^3, v^4]
    θ = [w1, w2, w3, w4]
    exp(dot(θ, f))
end

domain = (-1.0, 32.0)

Z = _integrate_simpsons(Ptilde_v, domain..., 100)
p_v = PGFPlots.Plots.Linear(x->Ptilde_v(x)/Z, domain, style="mark=none")
Axis(p_v, xmin=domain[1], xmax=domain[2], ymin=0.0, title=L"v")
# end


Out[4]:

In [5]:
using Interact

w1 = -9.0
w2 =  4.5
# @manipulate for w1 in linspace(-20.0,20.0,41),
#                 w2 in linspace(-10.0,10.0,41),
#                 w3 in linspace(-10.0,10.0,41),
#                 w4 in linspace(-10.0,10.0,41)
    
    function Ptilde_dv(dv::Float64)
        μ, σ = 0.0, 15.0
        dv = (dv - μ)/σ
        dv = clamp(dv, -1.0, 1.0)

        f = [dv^2, dv^4]
        θ = [w1, w2]
        exp(dot(θ, f))
    end

    domain = (-33.0, 33.0)

    Z = _integrate_simpsons(Ptilde_dv, domain..., 100)
p_dv = PGFPlots.Plots.Linear(x->Ptilde_dv(x)/Z, domain, style="mark=none")    
Axis(p_dv, xmin=domain[1], xmax=domain[2], ymin=0.0, title=L"\Delta v")
# end


Out[5]:

In [6]:
using Interact

w1 = -5.0
w2 = -7.5
w3 = 0.5
w4 = 2.0
# @manipulate for w1 in linspace(-20.0,20.0,41),
#                 w2 in linspace(-10.0,10.0,41),
#                 w3 in linspace(-10.0,10.0,41),
#                 w4 in linspace(-10.0,10.0,41)
    
    function Ptilde_ds(ds::Float64)
        μ, σ = 30.0, 70.0
        ds = (ds - μ)/σ
        ds = clamp(ds, -1.0, 1.0)

        f = [ds, ds^2, ds^3, ds^4]
        θ = [w1, w2, w3, w4]
        exp(dot(θ, f))
    end

    domain = (0.0, 100.0)

    Z = _integrate_simpsons(Ptilde_ds, domain..., 100)
    p_ds = PGFPlots.Plots.Linear(x->Ptilde_ds(x)/Z, domain, style="mark=none")
    Axis(p_ds, xmin=domain[1], xmax=domain[2], ymin=0.0, title=L"\Delta s")
# end


Out[6]:

AutoScenes Sampling


In [7]:
using AutomotiveDrivingModels
using AutoScenes
using AutoViz

scene, roadway = AutoScenes.get_start_scene_and_roadway(4)

car_colors = Dict{Int,Colorant}()
car_colors[2] = COLOR_CAR_EGO
car_colors[3] = COLOR_CAR_EGO
render(scene, roadway, cam=StaticCamera(VecE2(150.0,0.0), 8.0), canvas_height=150, car_colors=car_colors)


Out[7]:

In [8]:
factors = create_shared_factors()
structure = gen_scene_structure(scene, roadway, factors)
overlays = SceneOverlay[Overwash(RGBA(1.0,1.0,1.0,0.7)), SceneStructureOverlay(structure)]
render(scene, roadway, overlays, cam=StaticCamera(VecE2(150.0,0.0), 8.0), canvas_height=150, car_colors=car_colors)


Out[8]:

In [9]:
proposal_distribution = (Normal(0.0,10.0), Normal(0.0,1.0), Normal(0.0,2.0), Normal(0.0,0.2))
metropolis_hastings!(scene, structure, roadway, factors, proposal_distribution, 1000)
render(scene, roadway, overlays, cam=StaticCamera(VecE2(150.0,0.0), 8.0), canvas_height=150, car_colors=car_colors)


Out[9]:

In [10]:
using DataFrames
t = Float64[]
v=Float64[]
ϕ=Float64[]
Δv=Float64[]
Δs=Float64[]

for i in 1 : 1000
    ncars = rand(4:10)
    scene, roadway = AutoScenes.get_start_scene_and_roadway(ncars)
    structure = gen_scene_structure(scene, roadway, factors)
    metropolis_hastings!(scene, structure, roadway, factors, proposal_distribution, 2000)
    
    for j in 2 : length(scene)-1
        push!(t, scene[j].state.posF.t)
        push!(v, scene[j].state.v)
        push!(ϕ, scene[j].state.posF.ϕ)
    end
    
    for j in 2 : length(scene)
        push!(Δs, scene[j].state.posF.s - scene[j-1].state.posF.s - 0.5*scene[j-1].def.length - 0.5*scene[j].def.length)
        push!(Δv, scene[j].state.v - scene[j-1].state.v)
    end
end

"DONE"


Out[10]:
"DONE"

In [11]:
using PGFPlots

Axis([Plots.Histogram(t, discretization=:fd, density=true), p_t], ymin=0, title=L"t")


Out[11]:

In [12]:
Axis([Plots.Histogram(v, discretization=:fd, density=true),p_v], ymin=0, title=L"v")


Out[12]:

In [13]:
Axis([Plots.Histogram(ϕ, discretization=:fd, density=true), p_ϕ], ymin=0, title=L"ϕ")


Out[13]:

In [14]:
Axis([Plots.Histogram(Δv, discretization=:fd, density=true), p_dv], ymin=0, title=L"Δv")


Out[14]:

In [15]:
Axis([Plots.Histogram(Δs, discretization=:fd, density=true), p_ds], ymin=0, title=L"Δs")


Out[15]:

Learning


In [16]:
using AutomotiveDrivingModels
using AutoScenes
using AutoViz

factors = create_shared_factors()
scene, roadway = AutoScenes.get_start_scene_and_roadway(10)
proposal_distribution = (Normal(0.0,10.0), Normal(0.0,1.0), Normal(0.0,2.0), Normal(0.0,0.2))

vehdefs = Dict{Int, VehicleDef}()
vehdefs[1] = scene[1].def
vehdefs[2] = scene[2].def
vehdefs[3] = scene[3].def
vehdefs[4] = scene[4].def
vehdefs[5] = scene[5].def
vehdefs[6] = scene[6].def
vehdefs[7] = scene[7].def
vehdefs[8] = scene[8].def
vehdefs[9] = scene[9].def
vehdefs[10] = scene[10].def

n_scenes = 100
states = TrajdataState[]
frames = Array(TrajdataFrame, n_scenes)
sources = Array(AutoScenes.SceneSource, n_scenes)
structures = Array(SceneStructure, n_scenes)

state_index = 0
for frame in 1 : n_scenes
    ncars = rand(4:10)
    scene, roadway = AutoScenes.get_start_scene_and_roadway(ncars)
    structure = gen_scene_structure(scene, roadway, factors)
    metropolis_hastings!(scene, structure, roadway, factors, proposal_distribution, 1000)
    
    for (i,veh) in enumerate(scene)
        push!(states,TrajdataState(i, veh.state))
    end
    
    frames[frame] = TrajdataFrame(state_index+1, state_index+length(scene), convert(Float64, frame))
    sources[frame] = AutoScenes.SceneSource(1, frame)
    structures[frame] = structure
    
    state_index += length(scene)
end

dset = SceneStructureDataset(
    [Trajdata(roadway, vehdefs, states, frames)],
    sources, structures, factors)

length(dset)


Out[16]:
100

In [17]:
dat = PseudolikelihoodPrealloc(50);

In [18]:
tic()
plogl_opt = calc_pseudolikelihood(dset, dat=dat)
toc()
plogl_opt


elapsed time: 0.667070346 seconds
Out[18]:
-32.27871171167359

In [19]:
plogls = Float64[]
reset_weights!(dset.factors, 1.0)
tic()
push!(plogls, calc_pseudolikelihood(dset, dat=dat))
toc()
plogls[1]


elapsed time: 0.381285295 seconds
Out[19]:
-39.93915595717383

In [20]:
params = GradientStepParams(BatchSampler(dset))
params.grad_params.n_samples_monte_carlo_integration = 20
params.grad_params.n_samples_monte_carlo_pseudolikelihood = 20
params.factor_weight_min = -20.0
params.factor_weight_max =   5.0
params.gradient_min = -5.0
params.gradient_max = 5.0

learning_rate = 0.5
learning_rate_decay = 0.99
batch_size = 10
batch_size_increase = 2
t_start = now()

tic()
iter = 0
while iter < 500 # typemax(Int)
    iter += 1
    
    params.learning_rate = learning_rate
    params.batch_size = batch_size
    step!(params)
#     parallel_step!(params)
    
#     println("iter: ", iter)
#     println("time: ", now() - t_start)
    push!(plogls, calc_pseudolikelihood(dset, dat=dat, scene=params.grad_params.scene, rec=params.grad_params.rec))
# #     println("plogl: ", plogls[end])
#     println("learning rate: ", learning_rate)
#     println("batch_size:    ", batch_size)
#     println("n_samples:     ", )
#     println("weights: ")
#     for ϕ in dset.factors
#         println(ϕ.template.form, "  ", ϕ.weights)
#     end
#     println("")
    
    learning_rate *= learning_rate_decay
    batch_size = min(batch_size + batch_size_increase, length(dset))
end
toc()


1:   -0.152    -0.028    -0.032    -0.278    -0.022    -0.112    -0.414    -0.132  
2:   -0.276    -0.073    -0.032    -0.797    -0.017    -0.342  
3: 
1:   -0.232    -0.040    -0.021    -0.345     0.005    -0.112    -0.468    -0.215  
2:   -0.396    -0.123     0.005    -0.816     0.003    -0.348  
3: 
1:   -0.267    -0.043    -0.020    -0.303     0.025    -0.090    -0.400    -0.237  
2:   -0.413    -0.196     0.002    -0.676     0.014    -0.246  
3: 
1:   -0.279    -0.044     0.040    -0.253     0.024    -0.065    -0.310    -0.208  
2:   -0.446    -0.213    -0.034    -0.541     0.008    -0.182  
3: 
1:   -0.252    -0.046    -0.003    -0.199     0.021    -0.049    -0.260    -0.172  
2:   -0.420    -0.178    -0.017    -0.404    -0.001    -0.132  
3: 
1:   -0.232    -0.046    -0.004    -0.150     0.020    -0.035    -0.210    -0.136  
2:   -0.400    -0.160    -0.016    -0.344    -0.003    -0.103  
3: 
1:   -0.236    -0.041     0.011    -0.127     0.020    -0.026    -0.168    -0.112  
2:   -0.369    -0.147     0.009    -0.312    -0.009    -0.087  
3: 
1:   -0.221    -0.038     0.005    -0.104     0.019    -0.020    -0.131    -0.087  
2:   -0.343    -0.121    -0.008    -0.258    -0.007    -0.062  
3: 
1:   -0.222    -0.038     0.000    -0.098     0.013    -0.016    -0.102    -0.068  
2:   -0.306    -0.121     0.007    -0.229    -0.007    -0.056  
3: 
1:   -0.196    -0.037    -0.014    -0.093     0.013    -0.015    -0.092    -0.053  
2:   -0.290    -0.101     0.008    -0.203    -0.007    -0.048  
3: 
1:   -0.200    -0.036    -0.004    -0.084     0.011    -0.014    -0.088    -0.043  
2:   -0.261    -0.097    -0.010    -0.183    -0.010    -0.042  
3: 
1:   -0.197    -0.033    -0.019    -0.075     0.009    -0.013    -0.069    -0.042  
2:   -0.252    -0.081    -0.026    -0.156     0.005    -0.038  
3: 
1:   -0.196    -0.032    -0.005    -0.065     0.006    -0.011    -0.061    -0.039  
2:   -0.216    -0.079    -0.008    -0.160    -0.002    -0.030  
3: 
1:   -0.190    -0.032    -0.009    -0.063     0.007    -0.010    -0.043    -0.030  
2:   -0.204    -0.074     0.001    -0.149    -0.004    -0.028  
3: 
1:   -0.179    -0.031    -0.020    -0.057     0.008    -0.010    -0.050    -0.028  
2:   -0.191    -0.061    -0.021    -0.128     0.005    -0.027  
3: 
1:   -0.180    -0.029    -0.018    -0.052     0.007    -0.008    -0.046    -0.029  
2:   -0.185    -0.058    -0.029    -0.128     0.002    -0.026  
3: 
1:   -0.168    -0.029    -0.009    -0.048     0.006    -0.007    -0.029    -0.031  
2:   -0.169    -0.046    -0.013    -0.112    -0.003    -0.027  
3: 
1:   -0.157    -0.028    -0.007    -0.049     0.006    -0.007    -0.013    -0.029  
2:   -0.167    -0.036     0.001    -0.114    -0.002    -0.022  
3: 
1:   -0.157    -0.027    -0.009    -0.045     0.006    -0.006    -0.025    -0.028  
2:   -0.149    -0.034     0.008    -0.106     0.004    -0.020  
3: 
1:   -0.157    -0.025    -0.002    -0.043     0.005    -0.005    -0.022    -0.027  
2:   -0.146    -0.030     0.004    -0.108    -0.000    -0.020  
3: 
1:   -0.155    -0.024    -0.006    -0.043     0.005    -0.005    -0.019    -0.024  
2:   -0.146    -0.029    -0.013    -0.101    -0.003    -0.019  
3: 
1:   -0.152    -0.024    -0.002    -0.042     0.003    -0.004    -0.015    -0.025  
2:   -0.133    -0.027    -0.012    -0.089     0.002    -0.018  
3: 
1:   -0.144    -0.023    -0.015    -0.040     0.003    -0.005    -0.015    -0.023  
2:   -0.122    -0.028     0.004    -0.086    -0.002    -0.016  
3: 
1:   -0.141    -0.022    -0.017    -0.042     0.002    -0.005    -0.015    -0.026  
2:   -0.116    -0.026    -0.008    -0.079     0.001    -0.016  
3: 
1:   -0.130    -0.022    -0.011    -0.036     0.003    -0.005    -0.011    -0.024  
2:   -0.111    -0.025     0.008    -0.072     0.002    -0.016  
3: 
1:   -0.129    -0.021    -0.012    -0.040     0.003    -0.003    -0.015    -0.022  
2:   -0.108    -0.020    -0.007    -0.077     0.000    -0.014  
3: 
1:   -0.126    -0.021    -0.015    -0.037     0.004    -0.003    -0.017    -0.018  
2:   -0.101    -0.023    -0.000    -0.070    -0.000    -0.013  
3: 
1:   -0.125    -0.020    -0.005    -0.033     0.004    -0.003    -0.014    -0.015  
2:   -0.101    -0.020     0.014    -0.066     0.000    -0.011  
3: 
1:   -0.126    -0.018    -0.013    -0.032     0.004    -0.003    -0.010    -0.013  
2:   -0.103    -0.019     0.017    -0.061    -0.000    -0.010  
3: 
1:   -0.119    -0.019    -0.021    -0.029     0.003    -0.003    -0.012    -0.016  
2:   -0.092    -0.017     0.011    -0.063     0.003    -0.011  
3: 
1:   -0.112    -0.018    -0.009    -0.029     0.004    -0.003    -0.008    -0.014  
2:   -0.093    -0.014     0.014    -0.065     0.003    -0.011  
3: 
1:   -0.108    -0.018    -0.004    -0.031     0.003    -0.003    -0.007    -0.012  
2:   -0.088    -0.014     0.016    -0.065     0.005    -0.011  
3: 
1:   -0.101    -0.017    -0.003    -0.025     0.002    -0.002    -0.008    -0.014  
2:   -0.080    -0.013     0.019    -0.057     0.004    -0.008  
3: 
1:   -0.103    -0.017    -0.001    -0.025     0.002    -0.002    -0.003    -0.012  
2:   -0.078    -0.009     0.001    -0.055     0.003    -0.009  
3: 
1:   -0.099    -0.017    -0.009    -0.028     0.001    -0.002    -0.002    -0.011  
2:   -0.080    -0.009     0.006    -0.050     0.000    -0.008  
3: 
1:   -0.095    -0.016    -0.005    -0.026     0.001    -0.002    -0.007    -0.012  
2:   -0.073    -0.009     0.013    -0.051     0.002    -0.008  
3: 
1:   -0.096    -0.015    -0.010    -0.025     0.003    -0.002    -0.005    -0.011  
2:   -0.072    -0.007     0.004    -0.048     0.003    -0.008  
3: 
1:   -0.096    -0.015    -0.001    -0.024     0.002    -0.002    -0.004    -0.012  
2:   -0.070    -0.005    -0.002    -0.046     0.003    -0.008  
3: 
1:   -0.094    -0.014    -0.001    -0.023     0.001    -0.001    -0.007    -0.013  
2:   -0.070    -0.005    -0.000    -0.042     0.002    -0.007  
3: 
1:   -0.090    -0.014     0.001    -0.022     0.002    -0.002    -0.005    -0.011  
2:   -0.066    -0.006    -0.004    -0.042     0.002    -0.006  
3: 
1:   -0.088    -0.014    -0.001    -0.021     0.002    -0.001    -0.004    -0.011  
2:   -0.062    -0.004    -0.002    -0.044     0.001    -0.006  
3: 
1:   -0.087    -0.014    -0.004    -0.022     0.001    -0.001    -0.002    -0.010  
2:   -0.059    -0.004     0.009    -0.042     0.002    -0.007  
3: 
1:   -0.084    -0.013    -0.002    -0.021     0.001    -0.001    -0.001    -0.010  
2:   -0.059    -0.004     0.011    -0.037     0.001    -0.006  
3: 
1:   -0.081    -0.013    -0.007    -0.019     0.001    -0.001    -0.004    -0.010  
2:   -0.053    -0.003     0.004    -0.035     0.000    -0.006  
3: 
1:   -0.080    -0.012    -0.008    -0.019     0.001    -0.001    -0.003    -0.011  
2:   -0.054    -0.003     0.002    -0.036     0.003    -0.006  
3: 
1:   -0.077    -0.012    -0.011    -0.019     0.001    -0.001    -0.002    -0.010  
2:   -0.052    -0.003    -0.004    -0.036     0.003    -0.006  
3: 
1:   -0.076    -0.011    -0.011    -0.018     0.001    -0.001    -0.000    -0.010  
2:   -0.053    -0.002     0.001    -0.036     0.003    -0.005  
3: 
1:   -0.074    -0.011    -0.006    -0.018     0.001    -0.001    -0.001    -0.011  
2:   -0.052    -0.001     0.002    -0.035     0.003    -0.005  
3: 
1:   -0.074    -0.011    -0.005    -0.017     0.001    -0.001    -0.004    -0.011  
2:   -0.048    -0.001     0.007    -0.037     0.003    -0.005  
3: 
1:   -0.070    -0.011    -0.008    -0.017     0.001    -0.001    -0.002    -0.010  
2:   -0.047    -0.002     0.002    -0.035     0.003    -0.005  
3: 
1:   -0.070    -0.010    -0.003    -0.015     0.001    -0.000     0.002    -0.010  
2:   -0.047    -0.001    -0.001    -0.034     0.002    -0.005  
3: 
1:   -0.068    -0.010    -0.001    -0.015     0.001    -0.001     0.004    -0.009  
2:   -0.046    -0.001     0.001    -0.036     0.002    -0.005  
3: 
1:   -0.066    -0.010    -0.004    -0.015     0.000    -0.001     0.002    -0.009  
2:   -0.043    -0.000     0.001    -0.030     0.002    -0.004  
3: 
1:   -0.065    -0.010    -0.009    -0.016     0.001    -0.001     0.003    -0.009  
2:   -0.041     0.000    -0.001    -0.029     0.001    -0.004  
3: 
1:   -0.063    -0.009    -0.002    -0.015     0.001    -0.000     0.005    -0.008  
2:   -0.040     0.001     0.005    -0.029     0.001    -0.004  
3: 
1:   -0.063    -0.009    -0.006    -0.014     0.001    -0.000     0.004    -0.008  
2:   -0.039     0.001     0.003    -0.029     0.003    -0.004  
3: 
1:   -0.061    -0.009    -0.009    -0.013     0.001    -0.001     0.004    -0.008  
2:   -0.039     0.000     0.004    -0.028     0.002    -0.004  
3: 
1:   -0.059    -0.009    -0.008    -0.014     0.001    -0.000     0.003    -0.007  
2:   -0.038     0.001     0.006    -0.026     0.002    -0.004  
3: 
1:   -0.057    -0.008    -0.009    -0.013     0.001    -0.000     0.007    -0.007  
2:   -0.037     0.001    -0.010    -0.027     0.002    -0.003  
3: 
1:   -0.057    -0.008    -0.003    -0.012     0.001    -0.001     0.004    -0.008  
2:   -0.035     0.001    -0.006    -0.026     0.001    -0.003  
3: 
1:   -0.057    -0.008    -0.006    -0.013     0.001    -0.001     0.002    -0.007  
2:   -0.035     0.001    -0.010    -0.022     0.002    -0.003  
3: 
1:   -0.056    -0.008    -0.005    -0.012     0.001    -0.001    -0.000    -0.008  
2:   -0.033     0.002    -0.004    -0.023     0.001    -0.003  
3: 
1:   -0.053    -0.008    -0.004    -0.012     0.001    -0.000     0.001    -0.009  
2:   -0.034     0.001    -0.011    -0.023     0.001    -0.003  
3: 
1:   -0.053    -0.008     0.001    -0.013     0.001    -0.000     0.003    -0.008  
2:   -0.035     0.002    -0.013    -0.023     0.001    -0.003  
3: 
1:   -0.051    -0.008     0.002    -0.011     0.001     0.000     0.003    -0.007  
2:   -0.033     0.002    -0.003    -0.022     0.000    -0.003  
3: 
1:   -0.050    -0.007     0.001    -0.012     0.001    -0.000     0.002    -0.007  
2:   -0.033     0.002     0.004    -0.021     0.000    -0.003  
3: 
1:   -0.050    -0.007    -0.001    -0.011     0.000    -0.000     0.001    -0.007  
2:   -0.030     0.002     0.006    -0.022     0.000    -0.003  
3: 
1:   -0.049    -0.007    -0.002    -0.009     0.001    -0.000    -0.000    -0.008  
2:   -0.029     0.003     0.010    -0.019     0.001    -0.003  
3: 
1:   -0.049    -0.007    -0.004    -0.010     0.001     0.000     0.002    -0.007  
2:   -0.029     0.003     0.005    -0.019     0.001    -0.002  
3: 
1:   -0.049    -0.007    -0.005    -0.010     0.001     0.000     0.003    -0.008  
2:   -0.029     0.003     0.000    -0.019     0.000    -0.003  
3: 
1:   -0.048    -0.007    -0.002    -0.009     0.001     0.000     0.001    -0.008  
2:   -0.027     0.003     0.003    -0.019     0.002    -0.003  
3: 
1:   -0.046    -0.007    -0.002    -0.009     0.000     0.000     0.003    -0.007  
2:   -0.028     0.003     0.004    -0.016     0.001    -0.002  
3: 
1:   -0.044    -0.006    -0.008    -0.009     0.000     0.000     0.003    -0.007  
2:   -0.027     0.002    -0.002    -0.016     0.001    -0.002  
3: 
1:   -0.044    -0.006    -0.006    -0.009     0.001     0.000     0.003    -0.007  
2:   -0.028     0.002    -0.003    -0.017     0.001    -0.002  
3: 
1:   -0.043    -0.006    -0.001    -0.008     0.001     0.000     0.004    -0.006  
2:   -0.027     0.003    -0.002    -0.017     0.000    -0.002  
3: 
1:   -0.043    -0.006    -0.002    -0.009     0.001    -0.000     0.004    -0.006  
2:   -0.026     0.003    -0.007    -0.016     0.001    -0.002  
3: 
1:   -0.042    -0.006    -0.001    -0.009     0.001    -0.000     0.005    -0.007  
2:   -0.024     0.003    -0.010    -0.015     0.001    -0.002  
3: 
1:   -0.041    -0.006    -0.002    -0.008     0.001    -0.000     0.004    -0.007  
2:   -0.023     0.003    -0.009    -0.017     0.001    -0.002  
3: 
1:   -0.039    -0.005    -0.004    -0.008     0.001    -0.000     0.004    -0.007  
2:   -0.023     0.003     0.000    -0.016     0.001    -0.001  
3: 
1:   -0.038    -0.006    -0.003    -0.008     0.001     0.000     0.002    -0.007  
2:   -0.023     0.003     0.005    -0.016     0.001    -0.002  
3: 
1:   -0.037    -0.005     0.001    -0.008     0.001     0.000     0.004    -0.006  
2:   -0.022     0.003    -0.000    -0.016     0.001    -0.002  
3: 
1:   -0.037    -0.005     0.001    -0.008     0.001     0.000     0.004    -0.006  
2:   -0.023     0.003    -0.001    -0.017     0.000    -0.002  
3: 
1:   -0.036    -0.005     0.003    -0.008     0.001     0.000     0.001    -0.006  
2:   -0.023     0.003    -0.002    -0.015     0.000    -0.001  
3: 
1:   -0.037    -0.005    -0.000    -0.009     0.000     0.000     0.002    -0.006  
2:   -0.022     0.003    -0.003    -0.013     0.001    -0.001  
3: 
1:   -0.037    -0.005    -0.006    -0.008     0.000     0.000     0.002    -0.006  
2:   -0.022     0.003    -0.008    -0.012     0.000    -0.001  
3: 
1:   -0.036    -0.005    -0.008    -0.008     0.000     0.000     0.004    -0.005  
2:   -0.020     0.003     0.006    -0.014     0.001    -0.001  
3: 
1:   -0.036    -0.005    -0.001    -0.007     0.000     0.000     0.002    -0.006  
2:   -0.019     0.003     0.004    -0.012     0.000    -0.002  
3: 
1:   -0.034    -0.005     0.004    -0.006     0.000     0.000     0.003    -0.006  
2:   -0.019     0.003    -0.000    -0.012     0.000    -0.002  
3: 
1:   -0.034    -0.005    -0.001    -0.007     0.000     0.000     0.004    -0.006  
2:   -0.019     0.003    -0.008    -0.012     0.001    -0.001  
3: 
1:   -0.033    -0.004    -0.000    -0.007     0.000     0.000     0.004    -0.006  
2:   -0.019     0.003    -0.003    -0.011     0.001    -0.002  
3: 
1:   -0.033    -0.004    -0.001    -0.007     0.000     0.000     0.004    -0.006  
2:   -0.016     0.004    -0.003    -0.011     0.001    -0.001  
3: 
1:   -0.033    -0.005     0.001    -0.007    -0.000     0.000     0.002    -0.006  
2:   -0.018     0.003     0.001    -0.012     0.002    -0.001  
3: 
1:   -0.032    -0.004     0.002    -0.008    -0.000     0.000     0.001    -0.006  
2:   -0.017     0.003     0.002    -0.012     0.001    -0.001  
3: 
1:   -0.031    -0.004     0.005    -0.006    -0.000     0.000     0.002    -0.006  
2:   -0.016     0.003     0.001    -0.012     0.002    -0.001  
3: 
1:   -0.030    -0.004     0.002    -0.005     0.000     0.000     0.004    -0.005  
2:   -0.016     0.004     0.002    -0.011     0.002    -0.001  
3: 
1:   -0.030    -0.004    -0.000    -0.006     0.000     0.000     0.003    -0.005  
2:   -0.016     0.004    -0.001    -0.011     0.001    -0.001  
3: 
1:   -0.029    -0.004    -0.002    -0.007     0.000     0.000     0.002    -0.005  
2:   -0.017     0.004    -0.002    -0.010     0.001    -0.001  
3: 
1:   -0.028    -0.004    -0.005    -0.007    -0.000     0.000     0.002    -0.005  
2:   -0.015     0.004    -0.002    -0.010     0.001    -0.001  
3: 
1:   -0.028    -0.004    -0.005    -0.006     0.000     0.000     0.003    -0.005  
2:   -0.015     0.003     0.001    -0.010     0.001    -0.001  
3: 
1:   -0.028    -0.004    -0.000    -0.006     0.000     0.000     0.002    -0.005  
2:   -0.014     0.003     0.003    -0.009     0.001    -0.001  
3: 
1:   -0.028    -0.004    -0.001    -0.006     0.000     0.000     0.001    -0.005  
2:   -0.015     0.004     0.004    -0.009     0.001    -0.001  
3: 
1:   -0.028    -0.004    -0.002    -0.006     0.000     0.000     0.002    -0.005  
2:   -0.014     0.003     0.004    -0.009     0.001    -0.001  
3: 
1:   -0.027    -0.004    -0.006    -0.006     0.000     0.000     0.003    -0.005  
2:   -0.015     0.003     0.008    -0.009     0.001    -0.001  
3: 
1:   -0.027    -0.004    -0.003    -0.005     0.000     0.000     0.001    -0.005  
2:   -0.015     0.003     0.002    -0.010     0.001    -0.001  
3: 
1:   -0.026    -0.004     0.000    -0.005     0.000     0.000    -0.000    -0.005  
2:   -0.014     0.003     0.004    -0.010     0.001    -0.001  
3: 
1:   -0.024    -0.003     0.001    -0.006     0.000     0.000     0.002    -0.005  
2:   -0.012     0.003     0.009    -0.011     0.001    -0.001  
3: 
1:   -0.025    -0.003     0.003    -0.005     0.000     0.000     0.001    -0.005  
2:   -0.013     0.003     0.000    -0.011     0.001    -0.001  
3: 
1:   -0.025    -0.003     0.003    -0.006     0.000     0.000    -0.000    -0.005  
2:   -0.013     0.003    -0.001    -0.009     0.001    -0.001  
3: 
1:   -0.025    -0.003     0.000    -0.006     0.000     0.000     0.002    -0.005  
2:   -0.012     0.003     0.001    -0.008     0.001    -0.001  
3: 
1:   -0.024    -0.003    -0.003    -0.006     0.000     0.000     0.003    -0.005  
2:   -0.012     0.003     0.003    -0.007     0.001    -0.001  
3: 
1:   -0.024    -0.003     0.000    -0.006    -0.000     0.000     0.004    -0.005  
2:   -0.013     0.002     0.000    -0.008     0.000    -0.001  
3: 
1:   -0.023    -0.003     0.000    -0.005     0.000     0.000     0.004    -0.005  
2:   -0.012     0.003    -0.002    -0.008     0.000    -0.000  
3: 
1:   -0.023    -0.003    -0.002    -0.005     0.000     0.000     0.003    -0.005  
2:   -0.012     0.003    -0.001    -0.006     0.000    -0.001  
3: 
1:   -0.023    -0.003    -0.000    -0.004     0.000     0.000     0.002    -0.004  
2:   -0.012     0.003    -0.001    -0.007     0.001    -0.001  
3: 
1:   -0.023    -0.003     0.001    -0.005     0.000     0.000     0.001    -0.005  
2:   -0.011     0.004    -0.005    -0.008     0.001    -0.001  
3: 
1:   -0.022    -0.003     0.000    -0.005    -0.000     0.000     0.002    -0.004  
2:   -0.012     0.003    -0.001    -0.009     0.000    -0.001  
3: 
1:   -0.021    -0.003    -0.001    -0.004    -0.000     0.000     0.003    -0.004  
2:   -0.011     0.003    -0.000    -0.008     0.000    -0.001  
3: 
1:   -0.021    -0.003     0.001    -0.004    -0.000     0.000     0.002    -0.004  
2:   -0.012     0.003     0.002    -0.008     0.001    -0.000  
3: 
1:   -0.021    -0.003    -0.001    -0.003     0.000     0.000     0.001    -0.004  
2:   -0.011     0.003     0.003    -0.009     0.001    -0.001  
3: 
1:   -0.021    -0.003     0.001    -0.004     0.000     0.000    -0.000    -0.004  
2:   -0.010     0.004     0.003    -0.009     0.001    -0.000  
3: 
1:   -0.021    -0.003    -0.000    -0.004     0.000     0.000     0.001    -0.004  
2:   -0.011     0.003     0.001    -0.008     0.001    -0.000  
3: 
1:   -0.020    -0.003    -0.002    -0.004     0.000     0.000     0.001    -0.004  
2:   -0.011     0.003    -0.002    -0.007     0.000    -0.000  
3: 
1:   -0.020    -0.003    -0.002    -0.004     0.000     0.000     0.001    -0.004  
2:   -0.011     0.003    -0.002    -0.007     0.000    -0.000  
3: 
1:   -0.020    -0.002    -0.000    -0.003     0.000     0.000     0.002    -0.004  
2:   -0.011     0.003    -0.003    -0.007     0.000    -0.001  
3: 
1:   -0.020    -0.002     0.000    -0.003    -0.000     0.000     0.002    -0.004  
2:   -0.010     0.003    -0.005    -0.008     0.001    -0.000  
3: 
1:   -0.019    -0.002    -0.000    -0.004    -0.000     0.000     0.000    -0.004  
2:   -0.010     0.003    -0.001    -0.007     0.001    -0.001  
3: 
1:   -0.018    -0.002    -0.005    -0.004     0.000     0.000     0.002    -0.004  
2:   -0.010     0.003    -0.002    -0.007     0.001    -0.001  
3: 
1:   -0.018    -0.002    -0.000    -0.004    -0.000     0.000     0.003    -0.004  
2:   -0.010     0.003    -0.003    -0.007     0.001    -0.000  
3: 
1:   -0.018    -0.002    -0.002    -0.003    -0.000     0.000     0.002    -0.003  
2:   -0.009     0.003    -0.002    -0.006     0.000    -0.000  
3: 
1:   -0.018    -0.002    -0.003    -0.004     0.000     0.000     0.002    -0.003  
2:   -0.009     0.003    -0.001    -0.005     0.000    -0.000  
3: 
1:   -0.017    -0.002    -0.004    -0.004    -0.000     0.000     0.002    -0.003  
2:   -0.010     0.003     0.000    -0.006     0.001    -0.000  
3: 
1:   -0.018    -0.002    -0.002    -0.003    -0.000     0.000     0.002    -0.003  
2:   -0.010     0.003    -0.001    -0.006     0.000    -0.000  
3: 
1:   -0.017    -0.002    -0.003    -0.004     0.000     0.000     0.001    -0.003  
2:   -0.008     0.003     0.000    -0.006    -0.000    -0.001  
3: 
1:   -0.017    -0.002    -0.003    -0.003    -0.000     0.000     0.004    -0.004  
2:   -0.008     0.003     0.001    -0.008     0.000    -0.001  
3: 
1:   -0.016    -0.002    -0.003    -0.003     0.000     0.000     0.003    -0.004  
2:   -0.008     0.003     0.001    -0.007     0.000    -0.000  
3: 
1:   -0.016    -0.002    -0.005    -0.003     0.000     0.000     0.002    -0.003  
2:   -0.009     0.003    -0.001    -0.006     0.000    -0.000  
3: 
1:   -0.016    -0.002    -0.001    -0.003     0.000     0.000     0.001    -0.003  
2:   -0.008     0.003     0.001    -0.005     0.000    -0.000  
3: 
1:   -0.016    -0.002     0.002    -0.004     0.000     0.000     0.001    -0.003  
2:   -0.009     0.003     0.001    -0.006     0.000    -0.000  
3: 
1:   -0.016    -0.002    -0.001    -0.004     0.000     0.000     0.001    -0.003  
2:   -0.008     0.003     0.000    -0.005     0.001    -0.000  
3: 
1:   -0.015    -0.002     0.001    -0.003     0.000     0.000     0.002    -0.003  
2:   -0.009     0.003    -0.002    -0.005     0.001    -0.000  
3: 
1:   -0.015    -0.002    -0.000    -0.003     0.000     0.000     0.002    -0.004  
2:   -0.008     0.003    -0.001    -0.006     0.001    -0.000  
3: 
1:   -0.015    -0.002     0.001    -0.004    -0.000     0.000     0.002    -0.003  
2:   -0.009     0.003    -0.000    -0.004     0.001    -0.000  
3: 
1:   -0.015    -0.002    -0.002    -0.003     0.000     0.000     0.002    -0.003  
2:   -0.007     0.003     0.001    -0.004     0.001    -0.000  
3: 
1:   -0.015    -0.002    -0.002    -0.003     0.000     0.000     0.001    -0.003  
2:   -0.007     0.003     0.002    -0.005     0.000    -0.000  
3: 
1:   -0.015    -0.002     0.001    -0.003     0.000     0.000     0.002    -0.003  
2:   -0.007     0.003    -0.002    -0.006     0.000    -0.000  
3: 
1:   -0.015    -0.002     0.000    -0.003     0.000     0.000     0.001    -0.003  
2:   -0.006     0.003    -0.003    -0.006     0.000    -0.000  
3: 
1:   -0.014    -0.002     0.001    -0.003     0.000     0.000     0.000    -0.003  
2:   -0.007     0.003    -0.001    -0.005     0.000    -0.000  
3: 
1:   -0.014    -0.002     0.002    -0.003    -0.000     0.000     0.001    -0.003  
2:   -0.007     0.003     0.002    -0.005     0.001    -0.000  
3: 
1:   -0.014    -0.002     0.001    -0.003     0.000     0.000    -0.000    -0.003  
2:   -0.005     0.002     0.004    -0.004     0.001    -0.000  
3: 
1:   -0.013    -0.002     0.000    -0.003     0.000     0.000    -0.000    -0.003  
2:   -0.006     0.003    -0.001    -0.004     0.001    -0.000  
3: 
1:   -0.013    -0.002    -0.002    -0.003     0.000     0.000     0.000    -0.003  
2:   -0.007     0.003    -0.004    -0.004     0.001    -0.000  
3: 
1:   -0.013    -0.002    -0.001    -0.002     0.000     0.000     0.001    -0.003  
2:   -0.006     0.003    -0.002    -0.004     0.001    -0.000  
3: 
1:   -0.013    -0.002     0.001    -0.003     0.000     0.000     0.001    -0.003  
2:   -0.007     0.003     0.001    -0.004     0.000    -0.000  
3: 
1:   -0.012    -0.002     0.000    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.007     0.003     0.001    -0.004     0.001    -0.000  
3: 
1:   -0.012    -0.002     0.001    -0.003    -0.000     0.000     0.001    -0.003  
2:   -0.007     0.003     0.001    -0.004     0.001    -0.000  
3: 
1:   -0.012    -0.002     0.001    -0.003    -0.000     0.000     0.002    -0.003  
2:   -0.006     0.003     0.002    -0.004     0.000    -0.000  
3: 
1:   -0.012    -0.001     0.000    -0.003    -0.000     0.000     0.003    -0.003  
2:   -0.006     0.003    -0.002    -0.005     0.000    -0.000  
3: 
1:   -0.012    -0.002    -0.000    -0.003     0.000     0.000     0.002    -0.003  
2:   -0.006     0.003    -0.003    -0.004     0.001    -0.000  
3: 
1:   -0.012    -0.001     0.001    -0.003    -0.000     0.000     0.001    -0.003  
2:   -0.006     0.003    -0.001    -0.003     0.001    -0.000  
3: 
1:   -0.012    -0.001     0.000    -0.003    -0.000     0.000     0.002    -0.003  
2:   -0.006     0.003    -0.002    -0.003     0.001    -0.000  
3: 
1:   -0.011    -0.001    -0.000    -0.002     0.000     0.000     0.002    -0.003  
2:   -0.006     0.003    -0.002    -0.003     0.000    -0.000  
3: 
1:   -0.011    -0.001    -0.000    -0.002     0.000     0.000     0.002    -0.002  
2:   -0.006     0.003    -0.001    -0.003     0.000    -0.000  
3: 
1:   -0.011    -0.001     0.001    -0.002     0.000     0.000     0.001    -0.002  
2:   -0.006     0.003    -0.001    -0.003     0.000    -0.000  
3: 
1:   -0.011    -0.001     0.001    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.006     0.002     0.001    -0.004     0.000    -0.000  
3: 
1:   -0.011    -0.001     0.000    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.006     0.003    -0.001    -0.004     0.000    -0.000  
3: 
1:   -0.011    -0.001     0.000    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.005     0.002    -0.001    -0.004     0.000    -0.000  
3: 
1:   -0.011    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.005     0.002     0.002    -0.004     0.000    -0.000  
3: 
1:   -0.011    -0.001    -0.002    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.005     0.002    -0.000    -0.004     0.000    -0.000  
3: 
1:   -0.011    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.003  
2:   -0.005     0.002    -0.002    -0.003     0.000    -0.000  
3: 
1:   -0.011    -0.001    -0.002    -0.002     0.000     0.000     0.000    -0.002  
2:   -0.005     0.002     0.001    -0.004     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.001    -0.001     0.000     0.000     0.001    -0.002  
2:   -0.005     0.002     0.003    -0.004     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.001    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.005     0.002     0.002    -0.003     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.001    -0.002     0.000     0.000     0.002    -0.002  
2:   -0.005     0.002     0.000    -0.002     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.000    -0.003     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.001    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.005     0.002     0.000    -0.003     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.005     0.002    -0.001    -0.003     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.002    -0.002    -0.000     0.000     0.002    -0.002  
2:   -0.005     0.002     0.001    -0.003     0.000    -0.000  
3: 
1:   -0.010    -0.001    -0.002    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.001    -0.003     0.000    -0.000  
3: 
1:   -0.009    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.009    -0.001    -0.000    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.004    -0.002     0.001    -0.000  
3: 
1:   -0.009    -0.001     0.000    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.001    -0.003     0.001    -0.000  
3: 
1:   -0.009    -0.001     0.000    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.001    -0.003     0.001    -0.000  
3: 
1:   -0.009    -0.001     0.001    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.005     0.002     0.002    -0.003     0.001    -0.000  
3: 
1:   -0.009    -0.001     0.001    -0.002    -0.000     0.000     0.000    -0.002  
2:   -0.004     0.002    -0.001    -0.003     0.000    -0.000  
3: 
1:   -0.009    -0.001    -0.000    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.001    -0.003     0.000    -0.000  
3: 
1:   -0.008    -0.001     0.000    -0.002     0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.001    -0.003     0.000    -0.000  
3: 
1:   -0.008    -0.001    -0.000    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.001    -0.003     0.000    -0.000  
3: 
1:   -0.008    -0.001    -0.002    -0.002    -0.000     0.000     0.002    -0.002  
2:   -0.004     0.002    -0.002    -0.002     0.000    -0.000  
3: 
1:   -0.008    -0.001    -0.001    -0.002     0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.000    -0.003     0.000    -0.000  
3: 
1:   -0.008    -0.001    -0.001    -0.002     0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.001    -0.002     0.001    -0.000  
3: 
1:   -0.008    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.000    -0.002     0.000     0.000  
3: 
1:   -0.008    -0.001    -0.001    -0.002     0.000     0.000     0.000    -0.002  
2:   -0.004     0.002    -0.001    -0.002     0.000    -0.000  
3: 
1:   -0.008    -0.001    -0.001    -0.001     0.000     0.000     0.000    -0.002  
2:   -0.004     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.008    -0.001     0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.008    -0.001     0.000    -0.001    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.008    -0.001    -0.002    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.000    -0.003     0.000    -0.000  
3: 
1:   -0.008    -0.001    -0.002    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.002    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.000    -0.002     0.000     0.000  
3: 
1:   -0.007    -0.001    -0.001    -0.002    -0.000     0.000     0.001    -0.002  
2:   -0.003     0.002    -0.001    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001    -0.001    -0.001    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.001    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001    -0.000    -0.001    -0.000     0.000     0.001    -0.002  
2:   -0.003     0.002    -0.002    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001     0.000    -0.001    -0.000     0.000     0.001    -0.002  
2:   -0.004     0.002    -0.002    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001    -0.001    -0.001    -0.000     0.000     0.001    -0.002  
2:   -0.003     0.002     0.000    -0.002     0.000     0.000  
3: 
1:   -0.007    -0.001     0.000    -0.001    -0.000     0.000     0.001    -0.002  
2:   -0.003     0.002     0.001    -0.002     0.000     0.000  
3: 
1:   -0.007    -0.001    -0.001    -0.001     0.000     0.000     0.001    -0.002  
2:   -0.003     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001     0.001    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.003     0.002    -0.001    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001    -0.000    -0.001     0.000     0.000     0.001    -0.002  
2:   -0.004     0.002     0.000    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001    -0.001    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.003     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.006    -0.001    -0.001    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.004     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.007    -0.001    -0.001    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.002    -0.000    -0.002     0.000    -0.000  
3: 
1:   -0.006    -0.001    -0.001    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.003     0.002     0.001    -0.002     0.000     0.000  
3: 
1:   -0.006    -0.001    -0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.002    -0.001    -0.002     0.000     0.000  
3: 
1:   -0.006    -0.001    -0.001    -0.001     0.000     0.000     0.001    -0.002  
2:   -0.003     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.006    -0.001    -0.001    -0.001    -0.000     0.000     0.000    -0.002  
2:   -0.003     0.002     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.006    -0.001    -0.000    -0.001    -0.000     0.000     0.000    -0.002  
2:   -0.003     0.001     0.002    -0.002     0.000     0.000  
3: 
1:   -0.006    -0.001    -0.001    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.003     0.001     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.006    -0.001    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.003     0.001     0.000    -0.002     0.000    -0.000  
3: 
1:   -0.006    -0.001     0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.003     0.001    -0.001    -0.002     0.000     0.000  
3: 
1:   -0.006    -0.001    -0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.001    -0.000    -0.002     0.000    -0.000  
3: 
1:   -0.006    -0.001    -0.001    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.002    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.006    -0.001     0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.002    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.006    -0.001     0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.002    -0.001    -0.002     0.000    -0.000  
3: 
1:   -0.006    -0.001    -0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.002     0.000    -0.002     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.001    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.002     0.000    -0.002     0.000     0.000  
3: 
1:   -0.005    -0.001     0.000    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.003     0.001    -0.001    -0.002     0.000     0.000  
3: 
1:   -0.005    -0.001    -0.001    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.001    -0.002     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.000    -0.002  
2:   -0.002     0.001    -0.000    -0.002     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.001    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001    -0.001    -0.002     0.000     0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.001    -0.002     0.000     0.000  
3: 
1:   -0.005    -0.001     0.000    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.001    -0.002     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.003     0.001    -0.000    -0.002     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.003     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.005    -0.001     0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.005    -0.001     0.001    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000     0.000  
3: 
1:   -0.005    -0.001    -0.000    -0.001    -0.000     0.000    -0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.002     0.000    -0.000  
3: 
1:   -0.004    -0.001     0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.003     0.001    -0.000    -0.002     0.000     0.000  
3: 
1:   -0.004    -0.001    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.003     0.001    -0.001    -0.002     0.000     0.000  
3: 
1:   -0.005    -0.000    -0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.000    -0.002     0.000     0.000  
3: 
1:   -0.004    -0.000    -0.000    -0.001     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.000    -0.002     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.002     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.001    -0.001    -0.000     0.000    -0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000    -0.000  
3: 
1:   -0.004    -0.000    -0.001    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000    -0.000  
3: 
1:   -0.004    -0.000    -0.001    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.004    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.004    -0.000    -0.000    -0.000     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000    -0.000    -0.000     0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001     0.000     0.000    -0.000    -0.001  
2:   -0.002     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.004    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.001    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000     0.001    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000    -0.001    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000    -0.001    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001     0.000     0.000    -0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000    -0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.000    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000     0.001    -0.000     0.000     0.000     0.000    -0.001  
2:   -0.002     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.001     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001    -0.000     0.000     0.001    -0.001  
2:   -0.002     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.000    -0.000     0.000     0.001    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000    -0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.003    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.001    -0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.003    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.001     0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.001    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000    -0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000    -0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000    -0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000    -0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000    -0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.001    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.001    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.001    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.001     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.001  
2:   -0.001     0.001    -0.000    -0.001     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.001    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.001  
2:   -0.001     0.001     0.000    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.001     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.001    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.001    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.001    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.001     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.001     0.000    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000     0.001    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.001     0.000     0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.001     0.000    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.001     0.000    -0.000     0.000     0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.001    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.001    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.002    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.001     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.001     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000    -0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.001    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000    -0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000    -0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000     0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000    -0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000     0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000    -0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000     0.000    -0.000     0.000     0.000  
3: 
1:   -0.000    -0.000    -0.000    -0.000    -0.000     0.000     0.000    -0.000  
2:   -0.000     0.000    -0.000    -0.000     0.000     0.000  
3: 
elapsed time: 1366.873190934 seconds
Out[20]:
1366.873190934

In [21]:
using PGFPlots

Axis([Plots.Linear(collect(0:length(plogls)-1), plogls, style="blue, mark=none"), 
    Plots.Linear([0,length(plogls)-1], [plogl_opt, plogl_opt], style="red, mark=none, dashed")],
xlabel="iteration", ylabel = "pseudolikelihood", title="serial")


Out[21]:

Parallel


In [22]:
if nworkers() < 3
    addprocs(3) 
end

@everywhere using AutoScenes

plogls = Float64[]
reset_weights!(dset.factors, 1.0)
tic()
push!(plogls, calc_pseudolikelihood(dset, dat=dat))
toc()
plogls[1]

params = GradientStepParams(BatchSampler(dset))
params.grad_params.n_samples_monte_carlo_integration = 20
params.grad_params.n_samples_monte_carlo_pseudolikelihood = 20
params.factor_weight_min = -20.0
params.factor_weight_max =   5.0
params.gradient_min = -5.0
params.gradient_max = 5.0

learning_rate = 0.5
learning_rate_decay = 0.99
batch_size = 10
batch_size_increase = 2
t_start = now()

tic()
iter = 0
while iter < 500 # typemax(Int)
    iter += 1
    
    params.learning_rate = learning_rate
    params.batch_size = batch_size
    parallel_step!(params)
    
#     println("iter: ", iter)
#     println("time: ", now() - t_start)
    push!(plogls, calc_pseudolikelihood(dset, dat=dat, scene=params.grad_params.scene, rec=params.grad_params.rec))
# #     println("plogl: ", plogls[end])
#     println("learning rate: ", learning_rate)
#     println("batch_size:    ", batch_size)
#     println("n_samples:     ", )
#     println("weights: ")
#     for ϕ in dset.factors
#         println(ϕ.template.form, "  ", ϕ.weights)
#     end
#     println("")
    
    learning_rate *= learning_rate_decay
    batch_size = min(batch_size + batch_size_increase, length(dset))
end
toc()


elapsed time: 0.351935308 seconds
elapsed time: 1097.269667191 seconds
Out[22]:
1097.269667191

In [23]:
using PGFPlots

Axis([Plots.Linear(collect(0:length(plogls)-1), plogls, style="blue, mark=none"), 
    Plots.Linear([0,length(plogls)-1], [plogl_opt, plogl_opt], style="red, mark=none, dashed")],
xlabel="iteration", ylabel = "pseudolikelihood", title="parallel")


Out[23]:

In [24]:
using DataFrames
t = Float64[]
v=Float64[]
ϕ=Float64[]
Δv=Float64[]
Δs=Float64[]

for i in 1 : 1000
    ncars = rand(4:10)
    scene, roadway = AutoScenes.get_start_scene_and_roadway(ncars)
    structure = gen_scene_structure(scene, roadway, factors)
    metropolis_hastings!(scene, structure, roadway, factors, proposal_distribution, 2000)
    
    for j in 2 : length(scene)-1
        push!(t, scene[j].state.posF.t)
        push!(v, scene[j].state.v)
        push!(ϕ, scene[j].state.posF.ϕ)
    end
    
    for j in 2 : length(scene)
        push!(Δs, scene[j].state.posF.s - scene[j-1].state.posF.s - 0.5*scene[j-1].def.length - 0.5*scene[j].def.length)
        push!(Δv, scene[j].state.v - scene[j-1].state.v)
    end
end

"DONE"


Out[24]:
"DONE"

In [33]:
# NOTE: this is the marginal and it does not match perfectly because of the structure coupling -
#       a larger delta s between one pair of cars is a smaller delta s between the next pair

θ_ds2 = factors[2].weights[3:end]
function Ptilde_ds2(ds::Float64)
    μ, σ = 30.0, 70.0
    ds = (ds - μ)/σ
    ds = clamp(ds, -1.0, 1.0)

    f = [ds, ds^2, ds^3, ds^4]
    exp(dot(θ_ds2, f))
end

domain = (0.0, 100.0)
Z = _integrate_simpsons(Ptilde_ds2, domain..., 100)
p_ds2 = PGFPlots.Plots.Linear(x->Ptilde_ds2(x)/Z, domain, style="mark=none, black")

Axis([Plots.Histogram(Δs, discretization=:fd, density=true), p_ds, p_ds2], ymin=0, title=L"Δs")


WARNING: Method definition Ptilde_ds2(Float64) in module Main at In[32]:4 overwritten at In[33]:4.
Out[33]:

In [ ]: