diff --git a/.github/workflows/check-pep8.yml b/.github/workflows/check-pep8.yml
new file mode 100644
index 000000000..cc74941b8
--- /dev/null
+++ b/.github/workflows/check-pep8.yml
@@ -0,0 +1,15 @@
+name: autopep8
+on: push
+jobs:
+ autopep8:
+ runs-on: ubuntu-latest
+ steps:
+ - uses: actions/checkout@v2
+ - name: autopep8
+ id: autopep8
+ uses: peter-evans/autopep8@v1
+ with:
+ args: --recursive --diff --aggressive --aggressive --exit-code --ignore E402 --max-line-length 120 .
+ - name: Fail if autopep8 made changes
+ if: ${{ steps.autopep8.outputs.exit-code == 2 }}
+ run: exit 1
diff --git a/.github/workflows/checks.yaml b/.github/workflows/checks.yaml
new file mode 100644
index 000000000..48aa02cdb
--- /dev/null
+++ b/.github/workflows/checks.yaml
@@ -0,0 +1,10 @@
+name: Checks
+on: [push, pull_request]
+jobs:
+ checks:
+ runs-on: ubuntu-latest
+ steps:
+ - name: Check out repository
+ uses: actions/checkout@v2
+ - run: bash tools/check.sh
+ - run: bash tools/check-size.sh
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/.gitignore b/CHT/flow-over-plate/buoyantPimpleFoam-fenics/.gitignore
deleted file mode 100644
index 284fb914e..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/.gitignore
+++ /dev/null
@@ -1,5 +0,0 @@
-*.log
-Fluid
-Solid/VTK
-out
-*.txt
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/README.md b/CHT/flow-over-plate/buoyantPimpleFoam-fenics/README.md
deleted file mode 100644
index 7396eff88..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/README.md
+++ /dev/null
@@ -1,7 +0,0 @@
-# Tutorial for an CHT simulation of a flow over a heated plate using OpenFOAM and FEniCS
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-CHT:-Flow-over-a-heated-plate-with-OpenFOAM-and-FEniCS).
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/precice-config.xml b/CHT/flow-over-plate/buoyantPimpleFoam-fenics/precice-config.xml
deleted file mode 100644
index df507989f..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/precice-config.xml
+++ /dev/null
@@ -1,61 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Allclean b/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Allclean
deleted file mode 100755
index 39ed26a43..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Allclean
+++ /dev/null
@@ -1,48 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: OpenFOAM
-Participant1="OpenFOAM"
-cd ${Participant1}
- # Clean the case
- cleanCase
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-
- # Remove the log files
- rm -fv ${Participant1}_blockMesh.log
- rm -fv ${Participant1}_checkMesh.log
- rm -fv ${Participant1}_decomposePar.log
- rm -fv ${Participant1}.log
- rm -fv ${Participant1}_reconstructPar.log
- rm -fv \
- precice-*.log \
- precice-postProcessingInfo.log \
- precice-*-events.json
-cd ..
-
-# Participant 2: Nutils
-Participant2="Nutils"
-cd ${Participant2}
- echo "Cleaning" ${Participant2}
- rm -fv ${Participant2}.log
- rm -fv *.vtk
- rm -fv \
- precice-*.log \
- precice-*.json
-cd ..
-
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Allrun b/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Allrun
deleted file mode 100755
index cd8a320b6..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Allrun
+++ /dev/null
@@ -1,35 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-
-# Participant 1: OpenFOAM
-Participant1="OpenFOAM"
-cd ${Participant1}
- echo "Starting the ${Participant1} participant..."
- ./runFluid > ${Participant1}.log 2>&1 &
- PIDParticipant1=$!
-cd ..
-
-# Participant 2: Nutils
-Participant2="Nutils"
-cd ${Participant2}
- echo "Starting the ${Participant2} participant..."
- ./runSolid > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-cd ..
-
-# Wait for all the participants to finish
-echo "Waiting for the participants to exit..."
-echo "(you may run 'tail -f ${Participant1}/${Participant1}.log' in another terminal to check the progress)"
-wait ${PIDParticipant1}
-wait ${PIDParticipant2}
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
-else
- echo ""
- echo "The simulation completed!"
-fi
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Nutils/cht.py b/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Nutils/cht.py
deleted file mode 100644
index 001765c4a..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Nutils/cht.py
+++ /dev/null
@@ -1,136 +0,0 @@
-#! /usr/bin/env python3
-
-import nutils, numpy, treelog
-import precice
-from mpi4py import MPI
-
-
-def main(elemsize: 'mesh width in x and y direction' = 0.05,
- btype: 'type of basis function (std/spline)' = 'std',
- degree: 'polynomial degree' = 1,
- dt = .01):
-
- print("Running utils")
-
- # the mesh
- grid = [numpy.linspace(a, b, round((b-a)/size)+1) for (a,b,size) in [(0,1,elemsize), (-.25,0,elemsize), (0,.05,.05)]]
- domain, geom = nutils.mesh.rectilinear(grid, periodic=[2])
-
- # nutils namespace
- ns = nutils.function.Namespace()
- ns.x = geom
- ns.basis = domain.basis(btype, degree=degree)
- ns.u = 'basis_n ?lhs_n' # solution
- ns.dudt = 'basis_n (?lhs_n - ?lhs0_n) / ?dt'
- ns.flux = 'basis_n ?fluxdofs_n'
- ns.k = 100 # thermal diffusivity
- ns.uwall = 310 # wall temperature
-
- # the weak form
- res = domain.integral('(basis_n dudt + k basis_n,i u_,i) d:x' @ ns, degree=degree*2)
-
- # Dirichlet boundary condition
- sqr = domain.boundary['bottom'].integral('(u - uwall)^2 d:x' @ ns, degree=degree*2)
- cons = nutils.solver.optimize('lhs', sqr, droptol=1e-15)
-
- # preCICE setup
- configFileName = "../precice-config.xml"
- participantName = "Nutils"
- solverProcessIndex = 0
- solverProcessSize = 1
- interface = precice.Interface(participantName, configFileName, solverProcessIndex, solverProcessSize)
-
- # define coupling meshes
- meshNameGP = "Nutils-Mesh-GP" # Gauss points
- meshNameCC = "Nutils-Mesh-CC" # cell centers (potentially sub-sampled)
- meshIDGP = interface.get_mesh_id(meshNameGP)
- meshIDCC = interface.get_mesh_id(meshNameCC)
-
- couplinginterface = domain.boundary['top']
- couplingsampleGP = couplinginterface.sample('gauss', degree=degree*2)
- couplingsampleCC = couplinginterface.sample('uniform', 4) # number of sub-samples for better mapping
-
- verticesGP = couplingsampleGP.eval(ns.x)
- verticesCC = couplingsampleCC.eval(ns.x)
- dataIndicesGP = interface.set_mesh_vertices(meshIDGP, verticesGP)
- dataIndicesCC = interface.set_mesh_vertices(meshIDCC, verticesCC)
-
- # coupling data
- writeData = "Heat-Flux"
- readData = "Temperature"
- writedataID = interface.get_data_id(writeData, meshIDCC)
- readdataID = interface.get_data_id(readData, meshIDGP)
-
- # heat flux computation
- projectionmatrix = couplinginterface.integrate(ns.eval_nm('basis_n basis_m d:x'), degree=degree*2)
- projectioncons = numpy.zeros(res.shape)
- projectioncons[projectionmatrix.rowsupp(1e-15)] = numpy.nan
- fluxdofs = lambda v: projectionmatrix.solve(v, constrain=projectioncons)
-
- precice_dt = interface.initialize()
-
- cons0 = cons # to not lose the Dirichlet BC at the bottom
- lhs0 = numpy.zeros(res.shape)
- timestep = 1
-
- # project initial condition and visualize
- sqr = domain.integral('(u - uwall)^2' @ ns, degree=degree*2)
- lhs0 = nutils.solver.optimize('lhs', sqr)
- bezier = domain.sample('bezier', 2)
- x, u = bezier.eval(['x_i', 'u'] @ ns, lhs=lhs0)
- with treelog.add(treelog.DataLog()):
- nutils.export.vtk('Solid_0', bezier.tri, x, T=u)
-
-
- while interface.is_coupling_ongoing():
-
- # read temperature from interface
- if interface.is_read_data_available():
- readdata = interface.read_block_scalar_data(readdataID, dataIndicesGP)
- coupledata = couplingsampleGP.asfunction(readdata)
-
- sqr = couplingsampleGP.integral((ns.u - coupledata)**2)
- cons = nutils.solver.optimize('lhs', sqr, droptol=1e-15, constrain=cons0)
-
- # save checkpoint
- if interface.is_action_required(precice.action_write_iteration_checkpoint()):
- lhscheckpoint = lhs0
- interface.mark_action_fulfilled(precice.action_write_iteration_checkpoint())
-
- # potentially adjust non-matching timestep sizes
- dt = min(dt, precice_dt)
-
- # solve nutils timestep
- lhs = nutils.solver.solve_linear('lhs', res, constrain=cons, arguments=dict(lhs0=lhs0, dt=dt))
-
- # write heat fluxes to interface
- if interface.is_write_data_required(dt):
- fluxvalues = res.eval(lhs0=lhs0, lhs=lhs, dt=dt)
- writedata = couplingsampleCC.eval('-flux' @ ns, fluxdofs=fluxdofs(fluxvalues))
- interface.write_block_scalar_data(writedataID, dataIndicesCC, writedata)
-
- # do the coupling
- precice_dt = interface.advance(dt)
-
- # read checkpoint if required
- if interface.is_action_required(precice.action_read_iteration_checkpoint()):
- interface.mark_action_fulfilled(precice.action_read_iteration_checkpoint())
- lhs0 = lhscheckpoint
- else: # go to next timestep and visualize
- bezier = domain.sample('bezier', 2)
- x, u = bezier.eval(['x_i', 'u'] @ ns, lhs=lhs0)
- with treelog.add(treelog.DataLog()):
- if timestep % 20 == 0:
- nutils.export.vtk('Solid_' + str(timestep), bezier.tri, x, T=u)
- timestep += 1
- lhs0 = lhs
-
-
- interface.finalize()
-
-if __name__ == '__main__':
- nutils.cli.run(main)
-
-
-
-
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Nutils/runSolid b/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Nutils/runSolid
deleted file mode 100755
index 514c090fa..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/Nutils/runSolid
+++ /dev/null
@@ -1,13 +0,0 @@
-#!/bin/bash
-
-# Solid participant
-
-# Run this script in one terminal and the "runFluid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# The script "Allclean" cleans-up the result and log files.
-
-# Run
-python3 cht.py
-
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/runFluid b/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/runFluid
deleted file mode 100755
index a8ac3c11f..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/runFluid
+++ /dev/null
@@ -1,19 +0,0 @@
-#!/bin/bash
-
-# Fluid participant
-
-# Run this script in one terminal and the "runSolid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# The script "Allclean" cleans-up the result and log files.
-
-
-# Prepare
-blockMesh
-
-# Run
-buoyantPimpleFoam
-
-# Convert to vtk
-foamToVTK
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/README.md b/CHT/flow-over-plate/buoyantPimpleFoam-nutils/README.md
deleted file mode 100644
index b6481ab80..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/README.md
+++ /dev/null
@@ -1,68 +0,0 @@
-# Tutorial for an CHT simulation of a flow over a heated plate using OpenFOAM and Nutils
-
-## Case setup: flow over heated plate
-
-The setup for this tutorial is identical to the [flow over heated plate using OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Tutorial-for-CHT:-Flow-over-a-heated-plate#case-setup) with the only exception that the width of the scenario in z-direction is `0.05` instead of `0.4`.
-
-## Dependencies
-
-### Nutils
-
-[Nutils](http://www.nutils.org/en/latest/) is an open-source Python programming finite element library, developed by [Evalf Computing](http://evalf.com/).
-
-Clone and install via pip:
-
-```
-$ git clone https://github.com/nutils/nutils.git
-$ python3 -m pip install --user --editable nutils
-```
-
-For faster computations, you can optionally install `mkl`:
-
-```
-$ pip3 install mkl
-```
-
-### Other dependencies
-
-For running this tutorial, you further have to install
-
-* **preCICE**, see [preCICE wiki](https://github.com/precice/precice/wiki/Building).
-* **Python bindings**, see [`precice/python-bindings`](https://github.com/precice/python-bindings)
-* **OpenFOAM**, see [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-* **OpenFOAM adapter**, see [OpenFOAM adapter wiki](https://github.com/precice/openfoam-adapter/wiki/Building). If you have problems compiling, see the [troubleshooting section](https://github.com/precice/precice/wiki/CHT-with-OpenFOAM-and-FEniCS#troubleshooting) below.
-
-### Testing your installation
-
-* **OpenFOAM and OpenFOAM adapter:** To make sure that everything is working properly, you should run the [similar OpenFOAM-OpenFOAM tutorial case](https://github.com/precice/openfoam-adapter/wiki/Tutorial-for-CHT:-Flow-over-a-heated-plate).
-* **Nutils:** To make sure that Nutils is working properly, you should run at least one of the [Nutils examples](http://www.nutils.org/en/latest/examples/).
-
-## Run the tutorial
-
-Open two terminals at the root of this tutorial.
-
-Terminal 1:
-```
-$ cd OpenFOAM
-$ ./runFluid
-```
-
-Terminal 2:
-```
-$ cd Nutils
-$ python3 cht.py
-```
-
-Alternatively, you can also directly use the `Allrun` script in one terminal.
-
-### Visualization
-
-Both solvers, OpenFOAM and Nutils, create vtk output that you can, for example, load in Paraview.
-
-After 100 timesteps with `dt=0.01`:
-
-
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/precice-config.xml b/CHT/flow-over-plate/buoyantPimpleFoam-nutils/precice-config.xml
deleted file mode 100644
index e6d9e06b1..000000000
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/precice-config.xml
+++ /dev/null
@@ -1,61 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allclean b/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allclean
deleted file mode 100755
index e5bb21cb8..000000000
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allclean
+++ /dev/null
@@ -1,47 +0,0 @@
-#!/bin/bash
-
-echo "Cleaning..."
-
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Solid
-Participant1="Solid"
-rm -fv ${Participant1}/solid.mess
-rm -fv ${Participant1}/solid.resu
-rm -fv ${Participant1}/solid.rmed
-rm -fv ${Participant1}.log
-rm -fvr ${Participant1}/REPE_OUT
-mkdir ${Participant1}/REPE_OUT
-
-# Participant 2: Fluid
-Participant2="Fluid"
-rm -fv ${Participant2}.log
-cd ${Participant2}
- cleanCase
- touch Fluid.foam
- # Remove the log files
- rm -fv ${Participant2}_blockMesh.log
- rm -fv ${Participant2}_checkMesh.log
- rm -fv ${Participant2}_decomposePar.log
- rm -fv ${Participant2}_reconstructPar.log
-cd ..
-
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allrun b/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allrun
deleted file mode 100755
index e70d66f8e..000000000
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allrun
+++ /dev/null
@@ -1,96 +0,0 @@
-#!/bin/bash
-
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the scripts "runSolid" and "runFluid"
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- blockMesh > ${Participant1}_blockMesh.log 2>&1
- cd ..
-
- # Run and get the process id
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} buoyantSimpleFoam -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- buoyantSimpleFoam -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-export PRECICE_PARTICIPANT=${Participant2}
-export TUTORIAL_ROOT=${PWD}
-
- # Run
- echo " Starting the ${Participant2} participant..."
- as_run --run ${Participant2}/solid.export > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
- if [ $parallel -eq 1 ]; then
- echo "Reconstructing fields..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1 &
- fi
-
- # Workaround for issue #26
- echo "Problems with time directories without results? Run the script removeObsoleteFolders.sh and see issue #26 on GitHub."
- # ./removeObsoleteFolders.sh
-
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allrun_parallel b/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allrun_parallel
deleted file mode 100644
index b71529ac9..000000000
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Allrun_parallel
+++ /dev/null
@@ -1 +0,0 @@
-./Allrun -parallel
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/README.md b/CHT/flow-over-plate/buoyantSimpleFoam-aster/README.md
deleted file mode 100644
index 18926ed3d..000000000
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/README.md
+++ /dev/null
@@ -1,8 +0,0 @@
-# Tutorial for an CHT simulation of a flow over a heated plate using OpenFOAM and Code_Aster
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/code_aster-adapter/wiki/Flow-over-plate-Code_Aster-Tutorial).
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trademarks.
-This offering is not approved or endorsed by Électricité de France (EDF), producer and distributor of the Code_Aster software via www.code-aster.org, and owner of the Code_Aster trademark.
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/precice-config.xml b/CHT/flow-over-plate/buoyantSimpleFoam-aster/precice-config.xml
deleted file mode 100644
index 818aaa247..000000000
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/precice-config.xml
+++ /dev/null
@@ -1,56 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/runFluid b/CHT/flow-over-plate/buoyantSimpleFoam-aster/runFluid
deleted file mode 100755
index 2335cb9c4..000000000
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/runFluid
+++ /dev/null
@@ -1,4 +0,0 @@
-#!/bin/bash
-
- cd Fluid; blockMesh; cd ..
- buoyantSimpleFoam -case Fluid
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/runSolid b/CHT/flow-over-plate/buoyantSimpleFoam-aster/runSolid
deleted file mode 100755
index 795f56a0b..000000000
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/runSolid
+++ /dev/null
@@ -1,4 +0,0 @@
-#!/bin/bash
- export TUTORIAL_ROOT=${PWD}
- export PRECICE_PARTICIPANT=Solid
- as_run --run Solid/solid.export
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allclean b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allclean
deleted file mode 100755
index c2a67413b..000000000
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allclean
+++ /dev/null
@@ -1,70 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Inner-Fluid
-Participant1="Inner-Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Outer-Fluid
-Participant2="Outer-Fluid"
-cd ${Participant2}
- # Clean the case
- cleanCase
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant2}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant2}_blockMesh.log
-rm -fv ${Participant2}_checkMesh.log
-rm -fv ${Participant2}_decomposePar.log
-rm -fv ${Participant2}.log
-rm -fv ${Participant2}_reconstructPar.log
-
-# Participant 3: Solid
-Participant3="Solid"
-cd ${Participant3}
- # Delete result and log files
- rm -fv solid.cvg solid.dat solid.frd solid.sta
-cd ..
-rm -fv Solid.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-postProcessingInfo.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt iterations-${Participant3}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt convergence-${Participant3}.txt \
- Events-${Participant1}.log Events-${Participant2}.log Events-${Participant3}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log EventTimings-${Participant3}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allrun b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allrun
deleted file mode 100755
index ffa213537..000000000
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allrun
+++ /dev/null
@@ -1,68 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# You need to first download the mesh files separately using the Download_meshes script.
-# The script "Allclean" cleans-up the result and log files.
-
-if [ ! -f Solid/all.msh ]; then
- echo "Mesh files not found. Use the Download_meshes script to download them."
- exit
-fi
-
-# Participant 1: Inner-Fluid
-Participant1="Inner-Fluid"
-Solver1="buoyantSimpleFoam"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
- # Copy the backup of the mesh
- cp -r ${Participant1}/constant/polyMesh.org ${Participant1}/constant/polyMesh
-
- # Run and get the process id
- echo "Starting the ${Participant1} participant..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- PIDParticipant1=$!
-
-# Participant 2: outer-fluid
-Participant2="Outer-Fluid"
-Solver2="buoyantSimpleFoam"
-
- # Prepare
- echo "Preparing the ${Participant2} participant..."
- # Copy the backup of the mesh
- cp -r ${Participant2}/constant/polyMesh.org ${Participant2}/constant/polyMesh
-
- # Run and get the process id
- echo "Starting the ${Participant2} participant..."
- ${Solver2} -case ${Participant2} > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-# Participant 3: Solid
-Participant3="Solid"
-Solver3="ccx_preCICE"
-
- # Run and get the process id
- echo "Starting the ${Participant3} participant..."
- export OMP_NUM_THREADS=1
- export CCX_NPROC_EQUATION_SOLVER=1
- ${Solver3} -i ${Participant3}/solid -precice-participant ${Participant3} > ${Participant3}.log 2>&1 &
- PIDParticipant3=$!
-
-# Wait for all the participants to finish
-echo "Waiting for the participants to exit..."
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-wait ${PIDParticipant1}
-wait ${PIDParticipant2}
-wait ${PIDParticipant3}
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ] || [ "$(grep -c -E "*ERROR" ${Participant3}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
-else
- echo ""
- echo "The simulation completed!"
- echo "You may now open '${Participant1}/${Participant1}.foam' and '${Participant2}/${Participant2}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allrun_parallel b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allrun_parallel
deleted file mode 100755
index 42aaa6a6b..000000000
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Allrun_parallel
+++ /dev/null
@@ -1,80 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-
-# This script prepares and runs all the participants in one terminal, in parallel,
-# forwarding the solvers' output to log files.
-# You need to first download the mesh files separately using the Download_meshes script.
-# The script "Allclean" cleans-up the result and log files.
-
-if [ ! -f Solid/all.msh ]; then
- echo "Mesh files not found. Use the Download_meshes script to download them."
- exit
-fi
-
-# Participant 1: inner-fluid
-Participant1="Inner-Fluid"
-Solver1="buoyantSimpleFoam"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
- # Copy the backup of the mesh
- cp -r ${Participant1}/constant/polyMesh.org ${Participant1}/constant/polyMesh
-
- # Decompose the domain
- decomposePar -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
-
- # Run and get the process id
- echo "Starting the ${Participant1} participant..."
- mpirun -np 2 ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- PIDParticipant1=$!
-
-# Participant 2: outer-fluid
-Participant2="Outer-Fluid"
-Solver2="buoyantSimpleFoam"
-
- # Prepare
- echo "Preparing the ${Participant2} participant..."
- # Copy the backup of the mesh
- cp -r ${Participant2}/constant/polyMesh.org ${Participant2}/constant/polyMesh
-
- # Decompose the domain
- decomposePar -case ${Participant2} > ${Participant2}_decomposePar.log 2>&1
-
- # Run and get the process id
- echo "Starting the ${Participant2} participant..."
- mpirun -np 2 ${Solver2} -parallel -case ${Participant2} > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-# Participant 3: Solid
-Participant3="Solid"
-Solver3="ccx_preCICE"
-
- # Run and get the process id
- echo "Starting the ${Participant3} participant..."
- ${Solver3} -i ${Participant3}/solid -precice-participant ${Participant3} > ${Participant3}.log 2>&1 &
- PIDParticipant3=$!
-
-
-# Wait for all the participants to finish
-echo "Waiting for the participants to exit..."
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-wait ${PIDParticipant1}
-wait ${PIDParticipant2}
-wait ${PIDParticipant3}
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ] || [ "$(grep -c -E "*ERROR" ${Participant3}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
-else
- echo ""
- echo "The simulation completed!"
-
- # Reconstruct the cases
- echo "Reconstructing case ${Participant1}..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1
- echo "Reconstructing case ${Participant2}..."
- reconstructPar -case ${Participant2} > ${Participant2}_reconstructPar.log 2>&1
-
- echo "You may now open '${Participant1}/${Participant1}.foam' and '${Participant2}/${Participant2}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/Inner-Fluid.OpenFOAM b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/Inner-Fluid.OpenFOAM
deleted file mode 100644
index e69de29bb..000000000
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/Outer-Fluid.OpenFOAM b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/Outer-Fluid.OpenFOAM
deleted file mode 100644
index e69de29bb..000000000
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/README.md b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/README.md
deleted file mode 100644
index debd8fce2..000000000
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/README.md
+++ /dev/null
@@ -1,17 +0,0 @@
-# Tutorial for a shell-and-tube heat exchanger, using OpenFOAM and CalculiX.
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-CHT-with-OpenFOAM-and-CalculiX).
-
-It works with OpenFOAM 5.0 and CalculiX 2.12, but newer minor versions should work as well.
-
-Please run the script `Download_meshes` first.
-Then you may run the `Allrun` for a serial run,
-or the `Allrun_parallel` for a parallel run.
-
-You may adjust the end time in the precice-config_*.xml, or interupt the execution earlier if you want.
-
-Based on a case prepared with simscale.com.
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/config.yml b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/config.yml
deleted file mode 100644
index 4a6cc8215..000000000
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/config.yml
+++ /dev/null
@@ -1,14 +0,0 @@
-participants:
- # The configuration files for the Inner-Fluid and Outer-Fluid participants
- # are located in each participant's directory.
- Solid:
- interfaces:
- - mesh: Solid-to-Inner-Fluid
- patch: inner-interface
- read-data: [Sink-Temperature-Inner-Fluid, Heat-Transfer-Coefficient-Inner-Fluid]
- write-data: [Sink-Temperature-Solid, Heat-Transfer-Coefficient-Solid]
- - mesh: Solid-to-Outer-Fluid
- patch: outer-interface
- read-data: [Sink-Temperature-Outer-Fluid, Heat-Transfer-Coefficient-Outer-Fluid]
- write-data: [Sink-Temperature-Solid, Heat-Transfer-Coefficient-Solid]
-precice-config-file: precice-config.xml
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/inner-fluid.OpenFOAM b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/inner-fluid.OpenFOAM
deleted file mode 100644
index e69de29bb..000000000
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/precice-config.xml b/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/precice-config.xml
deleted file mode 100644
index 48d1ab1ec..000000000
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/precice-config.xml
+++ /dev/null
@@ -1,92 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/CONTRIBUTING.md b/CONTRIBUTING.md
new file mode 100644
index 000000000..d5e38d090
--- /dev/null
+++ b/CONTRIBUTING.md
@@ -0,0 +1,3 @@
+It is amazing that you want to contribute a tutorial case for preCICE!
+
+We welcome contributions and we have a few guidelines and tips that you can follow in the [preCICE website](https://precice.org/community-contribute-to-precice.html).
\ No newline at end of file
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Allclean b/FSI/3D_Tube/OpenFOAM-CalculiX/Allclean
deleted file mode 100755
index 6c9cdb6c6..000000000
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/Allclean
+++ /dev/null
@@ -1,58 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- #cleanCase
- rm -rfv 0
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid
-Participant2="Solid"
-cd ${Participant2}
- # Clean the case
- rm -fv *.log
- rm -fv tube.cvg
- rm -fv tube.dat
- rm -fv tube.frd
- rm -fv tube.sta
-cd ..
-# Remove the log files
-rm -fv spooles.out
-rm -fv ${Participant2}.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-postProcessingInfo.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Allrun b/FSI/3D_Tube/OpenFOAM-CalculiX/Allrun
deleted file mode 100755
index 35e748362..000000000
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/Allrun
+++ /dev/null
@@ -1,92 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-#./Allclean
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-Solver1="pimpleDyMFoam"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- echo " Restoring 0/ from 0.orig/..."
- rm -rfv 0
- cp -r 0.orig 0
- Solver1=$(getApplication) # solver
- echo " ${Participant1} Solver: ${Solver1}."
- cd ..
-
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-Solver2="ccx_preCICE"
-
- # Run and get the process id
- echo "Starting the ${Participant2} participant..."
- export OMP_NUM_THREADS=1
- export CCX_NPROC_EQUATION_SOLVER=1
- ${Solver2} -i ${Participant2}/tube -precice-participant Calculix > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-# Wait for all the participants to finish
- # =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-echo "To kill midrun, press 'c'. Ctrl+C will cause the processes to run in the background."
-# loop="ps -p ${PIDParticipant1}"
-while [ -e /proc/${PIDParticipant1} ]; do
- # loop="ps -p ${PIDParticipant1}"
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
- if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! Reconstructing fields (if parallel)"
- ./removeObsoleteFolders.sh # For some versions of openfoam, the functionobject is written in an empty timeolder. remove these.
- if [ $parallel -eq 1 ]; then
- reconstructPar -case ${Participant1} > ${Participant1}/reconstructPar.log 2>&1 &
- fi
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/Fluid.foam b/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/README.md b/FSI/3D_Tube/OpenFOAM-CalculiX/README.md
deleted file mode 100644
index cd1f47792..000000000
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/README.md
+++ /dev/null
@@ -1,19 +0,0 @@
-# Tutorial for an FSI simulation of a three-dimensional expanding tube scenario
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-OpenFOAM-and-CalculiX).
-
-It is known to work with OpenFOAM 4.1, 5.0, and CalculiX 2.15, but it should also work with newer versions. Have a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-The case files are prepared for the latest versions of OpenFOAM and use the solver `pimpleFoam`. **In case you are using a previous OpenFOAM version** you need to adjust the solver to `pimpleDyMFoam` in the `Fluid/system/controlDict` file.
-
-You may run the coupled simulation in serial using the script `Allrun` or in parallel with `Allrun -parallel` (`Allrun_parallel` is a shortcut to this). The output of each step will be redirected to log files. You can cleanup the simulation using `Allclean`.
-
-There is an [open issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. Please run the script `removeObsoleteSolvers.sh` to delete the additional files.
-
-You may adjust the end time in the precice-config_*.xml, or interupt the execution earlier if you want.
-
-This case was contributed by Kyle Davis (Universität Stuttgart).
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/all.msh b/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/all.msh
deleted file mode 100755
index 125dacb1e..000000000
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/all.msh
+++ /dev/null
@@ -1,12020 +0,0 @@
-*node, nset=Nall
-1, 5.000000e-02, -1.224647e-17, 0.000000e+00
-2, 5.000000e-02, -1.224647e-17, 5.000000e-01
-3, 6.000000e-02, -1.469576e-17, 0.000000e+00
-4, 6.000000e-02, -1.469576e-17, 5.000000e-01
-5, 4.900117e-02, 9.944087e-03, 5.000000e-01
-6, 4.579226e-02, 2.007658e-02, 5.000000e-01
-7, 4.048664e-02, 2.933994e-02, 5.000000e-01
-8, 3.332322e-02, 3.727684e-02, 5.000000e-01
-9, 2.525709e-02, 4.315182e-02, 5.000000e-01
-10, 1.574829e-02, 4.745515e-02, 5.000000e-01
-11, 4.935560e-03, 4.975581e-02, 5.000000e-01
-12, -5.996313e-03, 4.963914e-02, 5.000000e-01
-13, -1.617083e-02, 4.731284e-02, 5.000000e-01
-14, -2.614797e-02, 4.261788e-02, 5.000000e-01
-15, -3.441352e-02, 3.627271e-02, 5.000000e-01
-16, -4.106671e-02, 2.852236e-02, 5.000000e-01
-17, -4.591285e-02, 1.979925e-02, 5.000000e-01
-18, -4.905328e-02, 9.683794e-03, 5.000000e-01
-19, -4.998934e-02, -1.032392e-03, 5.000000e-01
-20, -4.863982e-02, -1.158310e-02, 5.000000e-01
-21, -4.509195e-02, -2.160361e-02, 5.000000e-01
-22, -3.990385e-02, -3.012777e-02, 5.000000e-01
-23, -3.312634e-02, -3.745191e-02, 5.000000e-01
-24, -2.480043e-02, -4.341588e-02, 5.000000e-01
-25, -1.468210e-02, -4.779577e-02, 5.000000e-01
-26, -4.825337e-03, -4.976662e-02, 5.000000e-01
-27, 5.179817e-03, -4.973097e-02, 5.000000e-01
-28, 1.661500e-02, -4.715869e-02, 5.000000e-01
-29, 2.665217e-02, -4.230440e-02, 5.000000e-01
-30, 3.452223e-02, -3.616926e-02, 5.000000e-01
-31, 4.101723e-02, -2.859347e-02, 5.000000e-01
-32, 4.605167e-02, -1.947419e-02, 5.000000e-01
-33, 4.900173e-02, -9.941354e-03, 5.000000e-01
-34, 5.000000e-02, -1.224647e-17, 1.178177e-02
-35, 5.000000e-02, -1.224647e-17, 2.218382e-02
-36, 5.000000e-02, -1.224647e-17, 3.291878e-02
-37, 5.000000e-02, -1.224647e-17, 4.560639e-02
-38, 5.000000e-02, -1.224647e-17, 5.557286e-02
-39, 5.000000e-02, -1.224647e-17, 6.659429e-02
-40, 5.000000e-02, -1.224647e-17, 7.766056e-02
-41, 5.000000e-02, -1.224647e-17, 8.939749e-02
-42, 5.000000e-02, -1.224647e-17, 9.982196e-02
-43, 5.000000e-02, -1.224647e-17, 1.105569e-01
-44, 5.000000e-02, -1.224647e-17, 1.232221e-01
-45, 5.000000e-02, -1.224647e-17, 1.331886e-01
-46, 5.000000e-02, -1.224647e-17, 1.442100e-01
-47, 5.000000e-02, -1.224647e-17, 1.553211e-01
-48, 5.000000e-02, -1.224647e-17, 1.670132e-01
-49, 5.000000e-02, -1.224647e-17, 1.774601e-01
-50, 5.000000e-02, -1.224647e-17, 1.881951e-01
-51, 5.000000e-02, -1.224647e-17, 2.008378e-01
-52, 5.000000e-02, -1.224647e-17, 2.108043e-01
-53, 5.000000e-02, -1.224647e-17, 2.218257e-01
-54, 5.000000e-02, -1.224647e-17, 2.329817e-01
-55, 5.000000e-02, -1.224647e-17, 2.446289e-01
-56, 5.000000e-02, -1.224647e-17, 2.550982e-01
-57, 5.000000e-02, -1.224647e-17, 2.658332e-01
-58, 5.000000e-02, -1.224647e-17, 2.784536e-01
-59, 5.000000e-02, -1.224647e-17, 2.884200e-01
-60, 5.000000e-02, -1.224647e-17, 2.994414e-01
-61, 5.000000e-02, -1.224647e-17, 3.106422e-01
-62, 5.000000e-02, -1.224647e-17, 3.222446e-01
-63, 5.000000e-02, -1.224647e-17, 3.327364e-01
-64, 5.000000e-02, -1.224647e-17, 3.434713e-01
-65, 5.000000e-02, -1.224647e-17, 3.560693e-01
-66, 5.000000e-02, -1.224647e-17, 3.660357e-01
-67, 5.000000e-02, -1.224647e-17, 3.770572e-01
-68, 5.000000e-02, -1.224647e-17, 3.883028e-01
-69, 5.000000e-02, -1.224647e-17, 3.998604e-01
-70, 5.000000e-02, -1.224647e-17, 4.103745e-01
-71, 5.000000e-02, -1.224647e-17, 4.225239e-01
-72, 5.000000e-02, -1.224647e-17, 4.324904e-01
-73, 5.000000e-02, -1.224647e-17, 4.435118e-01
-74, 5.000000e-02, -1.224647e-17, 4.555149e-01
-75, 5.000000e-02, -1.224647e-17, 4.663150e-01
-76, 5.000000e-02, -1.224647e-17, 4.772079e-01
-77, 5.000000e-02, -1.224647e-17, 4.878460e-01
-78, 4.900117e-02, 9.944087e-03, 0.000000e+00
-79, 4.579226e-02, 2.007658e-02, 0.000000e+00
-80, 4.048664e-02, 2.933994e-02, 0.000000e+00
-81, 3.332322e-02, 3.727684e-02, 0.000000e+00
-82, 2.525709e-02, 4.315182e-02, 0.000000e+00
-83, 1.574829e-02, 4.745515e-02, 0.000000e+00
-84, 4.935560e-03, 4.975581e-02, 0.000000e+00
-85, -5.996313e-03, 4.963914e-02, 0.000000e+00
-86, -1.617083e-02, 4.731284e-02, 0.000000e+00
-87, -2.614797e-02, 4.261788e-02, 0.000000e+00
-88, -3.441352e-02, 3.627271e-02, 0.000000e+00
-89, -4.106671e-02, 2.852236e-02, 0.000000e+00
-90, -4.591285e-02, 1.979925e-02, 0.000000e+00
-91, -4.905328e-02, 9.683794e-03, 0.000000e+00
-92, -4.998934e-02, -1.032392e-03, 0.000000e+00
-93, -4.863982e-02, -1.158310e-02, 0.000000e+00
-94, -4.509195e-02, -2.160361e-02, 0.000000e+00
-95, -3.990385e-02, -3.012777e-02, 0.000000e+00
-96, -3.312634e-02, -3.745191e-02, 0.000000e+00
-97, -2.480043e-02, -4.341588e-02, 0.000000e+00
-98, -1.468210e-02, -4.779577e-02, 0.000000e+00
-99, -4.825337e-03, -4.976662e-02, 0.000000e+00
-100, 5.179817e-03, -4.973097e-02, 0.000000e+00
-101, 1.661500e-02, -4.715869e-02, 0.000000e+00
-102, 2.665217e-02, -4.230440e-02, 0.000000e+00
-103, 3.452223e-02, -3.616926e-02, 0.000000e+00
-104, 4.101723e-02, -2.859347e-02, 0.000000e+00
-105, 4.605167e-02, -1.947419e-02, 0.000000e+00
-106, 4.900173e-02, -9.941354e-03, 0.000000e+00
-107, 5.899708e-02, 1.092448e-02, 0.000000e+00
-108, 5.626020e-02, 2.085162e-02, 0.000000e+00
-109, 5.205043e-02, 2.984547e-02, 0.000000e+00
-110, 4.641490e-02, 3.802180e-02, 0.000000e+00
-111, 3.950797e-02, 4.515662e-02, 0.000000e+00
-112, 3.104717e-02, 5.134270e-02, 0.000000e+00
-113, 2.176041e-02, 5.591498e-02, 0.000000e+00
-114, 1.223988e-02, 5.873828e-02, 0.000000e+00
-115, 1.340536e-03, 5.998502e-02, 0.000000e+00
-116, -8.571627e-03, 5.938457e-02, 0.000000e+00
-117, -1.824899e-02, 5.715745e-02, 0.000000e+00
-118, -2.786254e-02, 5.313830e-02, 0.000000e+00
-119, -3.658124e-02, 4.755852e-02, 0.000000e+00
-120, -4.392443e-02, 4.087352e-02, 0.000000e+00
-121, -5.046811e-02, 3.244949e-02, 0.000000e+00
-122, -5.520151e-02, 2.351156e-02, 0.000000e+00
-123, -5.832341e-02, 1.408473e-02, 0.000000e+00
-124, -5.986239e-02, 4.061345e-03, 0.000000e+00
-125, -5.960124e-02, -6.905962e-03, 0.000000e+00
-126, -5.764588e-02, -1.664188e-02, 0.000000e+00
-127, -5.411149e-02, -2.592194e-02, 0.000000e+00
-128, -4.905953e-02, -3.454218e-02, 0.000000e+00
-129, -4.216923e-02, -4.268203e-02, 0.000000e+00
-130, -3.455179e-02, -4.905276e-02, 0.000000e+00
-131, -2.574269e-02, -5.419699e-02, 0.000000e+00
-132, -1.635795e-02, -5.772710e-02, 0.000000e+00
-133, -6.612525e-03, -5.963451e-02, 0.000000e+00
-134, 3.314030e-03, -5.990841e-02, 0.000000e+00
-135, 1.314981e-02, -5.854129e-02, 0.000000e+00
-136, 2.262538e-02, -5.557060e-02, 0.000000e+00
-137, 3.157107e-02, -5.102223e-02, 0.000000e+00
-138, 3.978455e-02, -4.491314e-02, 0.000000e+00
-139, 4.664753e-02, -3.773602e-02, 0.000000e+00
-140, 5.250252e-02, -2.904282e-02, 0.000000e+00
-141, 5.657370e-02, -1.998539e-02, 0.000000e+00
-142, 5.917824e-02, -9.896273e-03, 0.000000e+00
-143, 5.899094e-02, 1.095761e-02, 5.000000e-01
-144, 5.624894e-02, 2.088198e-02, 5.000000e-01
-145, 5.203497e-02, 2.987243e-02, 5.000000e-01
-146, 4.639603e-02, 3.804482e-02, 5.000000e-01
-147, 3.948654e-02, 4.517536e-02, 5.000000e-01
-148, 3.102393e-02, 5.135675e-02, 5.000000e-01
-149, 2.173632e-02, 5.592435e-02, 5.000000e-01
-150, 1.221585e-02, 5.874328e-02, 5.000000e-01
-151, 1.317308e-03, 5.998554e-02, 5.000000e-01
-152, -8.593326e-03, 5.938143e-02, 5.000000e-01
-153, -1.826863e-02, 5.715118e-02, 5.000000e-01
-154, -2.787964e-02, 5.312933e-02, 5.000000e-01
-155, -3.659551e-02, 4.754754e-02, 5.000000e-01
-156, -4.393580e-02, 4.086130e-02, 5.000000e-01
-157, -5.047643e-02, 3.243655e-02, 5.000000e-01
-158, -5.520702e-02, 2.349861e-02, 5.000000e-01
-159, -5.832641e-02, 1.407231e-02, 5.000000e-01
-160, -5.986316e-02, 4.049908e-03, 5.000000e-01
-161, -5.960007e-02, -6.916049e-03, 5.000000e-01
-162, -5.764343e-02, -1.665038e-02, 5.000000e-01
-163, -5.410823e-02, -2.592874e-02, 5.000000e-01
-164, -4.905594e-02, -3.454728e-02, 5.000000e-01
-165, -4.216573e-02, -4.268550e-02, 5.000000e-01
-166, -3.454884e-02, -4.905485e-02, 5.000000e-01
-167, -2.574020e-02, -5.419817e-02, 5.000000e-01
-168, -1.635699e-02, -5.772737e-02, 5.000000e-01
-169, -6.612830e-03, -5.963447e-02, 5.000000e-01
-170, 3.312417e-03, -5.990850e-02, 5.000000e-01
-171, 1.314695e-02, -5.854193e-02, 5.000000e-01
-172, 2.262146e-02, -5.557220e-02, 5.000000e-01
-173, 3.156636e-02, -5.102514e-02, 5.000000e-01
-174, 3.977942e-02, -4.491767e-02, 5.000000e-01
-175, 4.664241e-02, -3.774236e-02, 5.000000e-01
-176, 5.249794e-02, -2.905110e-02, 5.000000e-01
-177, 5.657012e-02, -1.999555e-02, 5.000000e-01
-178, 5.917624e-02, -9.908184e-03, 5.000000e-01
-179, 6.000000e-02, -1.469576e-17, 1.178177e-02
-180, 6.000000e-02, -1.469576e-17, 2.218382e-02
-181, 6.000000e-02, -1.469576e-17, 3.291878e-02
-182, 6.000000e-02, -1.469576e-17, 4.560639e-02
-183, 6.000000e-02, -1.469576e-17, 5.557286e-02
-184, 6.000000e-02, -1.469576e-17, 6.659429e-02
-185, 6.000000e-02, -1.469576e-17, 7.766056e-02
-186, 6.000000e-02, -1.469576e-17, 8.939749e-02
-187, 6.000000e-02, -1.469576e-17, 9.982196e-02
-188, 6.000000e-02, -1.469576e-17, 1.105569e-01
-189, 6.000000e-02, -1.469576e-17, 1.232221e-01
-190, 6.000000e-02, -1.469576e-17, 1.331886e-01
-191, 6.000000e-02, -1.469576e-17, 1.442100e-01
-192, 6.000000e-02, -1.469576e-17, 1.553211e-01
-193, 6.000000e-02, -1.469576e-17, 1.670132e-01
-194, 6.000000e-02, -1.469576e-17, 1.774601e-01
-195, 6.000000e-02, -1.469576e-17, 1.881951e-01
-196, 6.000000e-02, -1.469576e-17, 2.008378e-01
-197, 6.000000e-02, -1.469576e-17, 2.108043e-01
-198, 6.000000e-02, -1.469576e-17, 2.218257e-01
-199, 6.000000e-02, -1.469576e-17, 2.329817e-01
-200, 6.000000e-02, -1.469576e-17, 2.446289e-01
-201, 6.000000e-02, -1.469576e-17, 2.550982e-01
-202, 6.000000e-02, -1.469576e-17, 2.658332e-01
-203, 6.000000e-02, -1.469576e-17, 2.784536e-01
-204, 6.000000e-02, -1.469576e-17, 2.884200e-01
-205, 6.000000e-02, -1.469576e-17, 2.994414e-01
-206, 6.000000e-02, -1.469576e-17, 3.106422e-01
-207, 6.000000e-02, -1.469576e-17, 3.222446e-01
-208, 6.000000e-02, -1.469576e-17, 3.327364e-01
-209, 6.000000e-02, -1.469576e-17, 3.434713e-01
-210, 6.000000e-02, -1.469576e-17, 3.560693e-01
-211, 6.000000e-02, -1.469576e-17, 3.660357e-01
-212, 6.000000e-02, -1.469576e-17, 3.770572e-01
-213, 6.000000e-02, -1.469576e-17, 3.883028e-01
-214, 6.000000e-02, -1.469576e-17, 3.998604e-01
-215, 6.000000e-02, -1.469576e-17, 4.103745e-01
-216, 6.000000e-02, -1.469576e-17, 4.225239e-01
-217, 6.000000e-02, -1.469576e-17, 4.324904e-01
-218, 6.000000e-02, -1.469576e-17, 4.435118e-01
-219, 6.000000e-02, -1.469576e-17, 4.555149e-01
-220, 6.000000e-02, -1.469576e-17, 4.663150e-01
-221, 6.000000e-02, -1.469576e-17, 4.772079e-01
-222, 6.000000e-02, -1.469576e-17, 4.878460e-01
-223, 4.810903e-02, 1.362062e-02, 4.899511e-01
-224, 3.781359e-02, 3.271288e-02, 4.891045e-01
-225, 2.073388e-02, 4.549842e-02, 4.901007e-01
-226, -2.343718e-04, 4.999945e-02, 4.888356e-01
-227, -2.150295e-02, 4.514004e-02, 4.883044e-01
-228, -3.794587e-02, 3.255934e-02, 4.898866e-01
-229, -4.786769e-02, 1.444589e-02, 4.902520e-01
-230, -4.959964e-02, -6.314722e-03, 4.888243e-01
-231, -4.279874e-02, -2.585087e-02, 4.899151e-01
-232, -2.869832e-02, -4.094395e-02, 4.904035e-01
-233, -9.571400e-03, -4.907533e-02, 4.888392e-01
-234, 1.134130e-02, -4.869676e-02, 4.905568e-01
-235, 3.064736e-02, -3.950619e-02, 4.899582e-01
-236, 4.423052e-02, -2.331655e-02, 4.903957e-01
-237, 4.949522e-02, -7.086865e-03, 1.235364e-02
-238, 4.913527e-02, -9.258812e-03, 2.521021e-02
-239, 4.914754e-02, -9.193464e-03, 3.741453e-02
-240, 4.902186e-02, -9.841630e-03, 4.935464e-02
-241, 4.889289e-02, -1.046354e-02, 6.040872e-02
-242, 4.884461e-02, -1.068662e-02, 7.178807e-02
-243, 4.881778e-02, -1.080853e-02, 8.317887e-02
-244, 4.883306e-02, -1.073928e-02, 9.423230e-02
-245, 4.902467e-02, -9.827590e-03, 1.050870e-01
-246, 4.902258e-02, -9.838027e-03, 1.166875e-01
-247, 4.873994e-02, -1.115430e-02, 1.275837e-01
-248, 4.872352e-02, -1.122579e-02, 1.384255e-01
-249, 4.880579e-02, -1.086254e-02, 1.496594e-01
-250, 4.887290e-02, -1.055650e-02, 1.610813e-01
-251, 4.881452e-02, -1.082327e-02, 1.724307e-01
-252, 4.872772e-02, -1.120756e-02, 1.836825e-01
-253, 4.865425e-02, -1.152231e-02, 1.949340e-01
-254, 4.862432e-02, -1.164800e-02, 2.059902e-01
-255, 4.884771e-02, -1.067245e-02, 2.166627e-01
-256, 4.893950e-02, -1.024329e-02, 2.278513e-01
-257, 4.898239e-02, -1.003619e-02, 2.385634e-01
-258, 4.896961e-02, -1.009839e-02, 2.498138e-01
-259, 4.883784e-02, -1.071754e-02, 2.608035e-01
-260, 4.881150e-02, -1.083684e-02, 2.721236e-01
-261, 4.880697e-02, -1.085726e-02, 2.831655e-01
-262, 4.901813e-02, -9.860190e-03, 2.939046e-01
-263, 4.901813e-02, -9.860158e-03, 3.052935e-01
-264, 4.881963e-02, -1.080019e-02, 3.162193e-01
-265, 4.875310e-02, -1.109662e-02, 3.271825e-01
-266, 4.890234e-02, -1.041926e-02, 3.380791e-01
-267, 4.889226e-02, -1.046646e-02, 3.496386e-01
-268, 4.862196e-02, -1.165784e-02, 3.606263e-01
-269, 4.856210e-02, -1.190473e-02, 3.717111e-01
-270, 4.861201e-02, -1.169926e-02, 3.829571e-01
-271, 4.876130e-02, -1.106055e-02, 3.941459e-01
-272, 4.898076e-02, -1.004417e-02, 4.051261e-01
-273, 4.900933e-02, -9.903822e-03, 4.167101e-01
-274, 4.875505e-02, -1.108805e-02, 4.277030e-01
-275, 4.871564e-02, -1.125994e-02, 4.387590e-01
-276, 4.884018e-02, -1.070684e-02, 4.500806e-01
-277, 4.898484e-02, -1.002427e-02, 4.613840e-01
-278, 4.918303e-02, -9.001663e-03, 4.721766e-01
-279, 4.941879e-02, -7.601548e-03, 4.822216e-01
-280, 4.830940e-02, 1.289192e-02, 9.186399e-03
-281, 4.425063e-02, 2.327835e-02, 9.390588e-03
-282, 3.822160e-02, 3.223521e-02, 9.650209e-03
-283, 3.054815e-02, 3.958295e-02, 9.414495e-03
-284, 2.133163e-02, 4.522125e-02, 9.076604e-03
-285, 1.092242e-02, 4.879242e-02, 9.268479e-03
-286, 3.883677e-04, 4.999849e-02, 1.012954e-02
-287, -1.018669e-02, 4.895132e-02, 1.079531e-02
-288, -2.024010e-02, 4.572022e-02, 9.890285e-03
-289, -2.924812e-02, 4.055302e-02, 1.000207e-02
-290, -3.699225e-02, 3.363887e-02, 1.069402e-02
-291, -4.309621e-02, 2.535186e-02, 9.696127e-03
-292, -4.742738e-02, 1.583172e-02, 9.877122e-03
-293, -4.969004e-02, 5.558772e-03, 1.073335e-02
-294, -4.973899e-02, -5.102215e-03, 1.087807e-02
-295, -4.750847e-02, -1.558670e-02, 1.075744e-02
-296, -4.313556e-02, -2.528485e-02, 1.036763e-02
-297, -3.729282e-02, -3.330534e-02, 9.438801e-03
-298, -2.948629e-02, -4.038018e-02, 9.394313e-03
-299, -2.059146e-02, -4.556305e-02, 1.034304e-02
-300, -1.026309e-02, -4.893535e-02, 1.122927e-02
-301, 3.153563e-04, -4.999901e-02, 1.125056e-02
-302, 1.093774e-02, -4.878899e-02, 1.096832e-02
-303, 2.086015e-02, -4.544067e-02, 9.318886e-03
-304, 3.007170e-02, -3.994613e-02, 8.724352e-03
-305, 3.754318e-02, -3.302286e-02, 9.561463e-03
-306, 4.301589e-02, -2.548790e-02, 9.589398e-03
-307, 4.944441e-02, 7.433028e-03, 1.772513e-02
-308, 4.900441e-02, 9.928127e-03, 3.854567e-02
-309, 4.882203e-02, 1.078931e-02, 6.131748e-02
-310, 4.896440e-02, 1.012360e-02, 8.371263e-02
-311, 4.901430e-02, 9.879170e-03, 1.057694e-01
-312, 4.888218e-02, 1.051347e-02, 1.277908e-01
-313, 4.870736e-02, 1.129571e-02, 1.504215e-01
-314, 4.900874e-02, 9.906723e-03, 1.730906e-01
-315, 4.850633e-02, 1.212997e-02, 1.943703e-01
-316, 4.885153e-02, 1.065493e-02, 2.159842e-01
-317, 4.869424e-02, 1.135212e-02, 2.395948e-01
-318, 4.923907e-02, 8.689905e-03, 2.610500e-01
-319, 4.920733e-02, 8.867871e-03, 2.830837e-01
-320, 4.861165e-02, 1.170075e-02, 3.047413e-01
-321, 4.894514e-02, 1.021630e-02, 3.279027e-01
-322, 4.841251e-02, 1.249915e-02, 3.494655e-01
-323, 4.869503e-02, 1.134874e-02, 3.715812e-01
-324, 4.866132e-02, 1.149245e-02, 3.956296e-01
-325, 4.880668e-02, 1.085854e-02, 4.168585e-01
-326, 4.873840e-02, 1.116102e-02, 4.383490e-01
-327, 4.934155e-02, 8.087743e-03, 4.611287e-01
-328, 4.936193e-02, 7.962382e-03, 4.813129e-01
-329, 4.817855e-02, -1.337264e-02, 4.909186e-01
-330, 4.385988e-02, 2.400647e-02, 4.893972e-01
-331, 2.990732e-02, 4.006934e-02, 4.899827e-01
-332, 1.060996e-02, 4.886132e-02, 4.893391e-01
-333, -1.100873e-02, 4.877303e-02, 4.884133e-01
-334, -3.074811e-02, 3.942783e-02, 4.887606e-01
-335, -4.382313e-02, 2.407350e-02, 4.908117e-01
-336, -4.978559e-02, 4.625499e-03, 4.890509e-01
-337, -4.718537e-02, -1.653906e-02, 4.893656e-01
-338, -3.652988e-02, -3.414042e-02, 4.905610e-01
-339, -1.961292e-02, -4.599275e-02, 4.891411e-01
-340, 8.253570e-04, -4.999319e-02, 4.891994e-01
-341, 2.164440e-02, -4.507238e-02, 4.907456e-01
-342, 3.824516e-02, -3.220726e-02, 4.898826e-01
-343, 4.690598e-02, -1.731557e-02, 1.469353e-02
-344, 4.892245e-02, 1.032441e-02, 4.996549e-02
-345, 4.924365e-02, 8.663909e-03, 2.747298e-02
-346, 4.882363e-02, 1.078209e-02, 7.277467e-02
-347, 4.911061e-02, 9.388731e-03, 9.475752e-02
-348, 4.876363e-02, 1.105026e-02, 1.167448e-01
-349, 4.885329e-02, 1.064690e-02, 1.391204e-01
-350, 4.877884e-02, 1.098295e-02, 1.619096e-01
-351, 4.931827e-02, 8.228521e-03, 1.833290e-01
-352, 4.915752e-02, 9.139940e-03, 2.054857e-01
-353, 4.877105e-02, 1.101748e-02, 2.277682e-01
-354, 4.886397e-02, 1.059777e-02, 2.508050e-01
-355, 4.847294e-02, 1.226270e-02, 2.721304e-01
-356, 4.882988e-02, 1.075375e-02, 2.933542e-01
-357, 4.867445e-02, 1.143670e-02, 3.164561e-01
-358, 4.927201e-02, 8.501124e-03, 3.383539e-01
-359, 4.909735e-02, 9.457835e-03, 3.608159e-01
-360, 4.861226e-02, 1.169820e-02, 3.836745e-01
-361, 4.917608e-02, 9.039521e-03, 4.060524e-01
-362, 4.917532e-02, 9.043647e-03, 4.275680e-01
-363, 4.886444e-02, 1.059558e-02, 4.505546e-01
-364, 4.916619e-02, 9.093186e-03, 4.712224e-01
-365, 4.724046e-02, 1.638105e-02, 1.959359e-02
-366, 1.670858e-02, 4.712561e-02, 4.780489e-01
-367, 4.178476e-02, 2.745968e-02, 4.760694e-01
-368, -5.388630e-03, 4.970878e-02, 4.763524e-01
-369, -2.729412e-02, 4.189309e-02, 4.743955e-01
-370, 4.443429e-02, 2.292583e-02, 1.445893e-01
-371, -4.159174e-02, 2.775117e-02, 4.808390e-01
-372, -4.874121e-02, 1.114876e-02, 4.770315e-01
-373, -4.866459e-02, -1.147857e-02, 4.765543e-01
-374, -3.930919e-02, -3.089964e-02, 4.794152e-01
-375, -2.479120e-02, -4.342115e-02, 4.775891e-01
-376, -1.474137e-02, -4.777753e-02, 4.762294e-01
-377, 7.428965e-03, -4.944502e-02, 4.784269e-01
-378, 2.602915e-02, -4.269055e-02, 4.793681e-01
-379, 4.194875e-02, -2.720850e-02, 4.793378e-01
-380, 4.482573e-02, 2.215071e-02, 6.796312e-02
-381, 4.499996e-02, 2.179458e-02, 1.696140e-01
-382, 2.567566e-02, 4.290409e-02, 4.804435e-01
-383, 6.065803e-03, 4.963070e-02, 4.773230e-01
-384, 4.617398e-02, 1.918237e-02, 9.029569e-02
-385, 4.589570e-02, -1.983897e-02, 2.992445e-02
-386, 4.627932e-02, -1.892681e-02, 4.205645e-02
-387, 4.495959e-02, -2.187774e-02, 5.304327e-02
-388, 4.494888e-02, -2.189973e-02, 6.492768e-02
-389, 4.469296e-02, -2.241740e-02, 7.716798e-02
-390, 4.430180e-02, -2.318082e-02, 8.879351e-02
-391, 4.482888e-02, -2.214433e-02, 1.001173e-01
-392, 4.609650e-02, -1.936784e-02, 1.105790e-01
-393, 4.455828e-02, -2.268390e-02, 1.207995e-01
-394, 4.365345e-02, -2.437983e-02, 1.320238e-01
-395, 4.433692e-02, -2.311358e-02, 1.434469e-01
-396, 4.481696e-02, -2.216845e-02, 1.553953e-01
-397, 4.485094e-02, -2.209962e-02, 1.667221e-01
-398, 4.452106e-02, -2.275687e-02, 1.785093e-01
-399, 4.371220e-02, -2.427434e-02, 1.899152e-01
-400, 4.338934e-02, -2.484683e-02, 2.015952e-01
-401, 4.374488e-02, -2.421540e-02, 2.130983e-01
-402, 4.540945e-02, -2.092802e-02, 2.230881e-01
-403, 4.450673e-02, -2.278488e-02, 2.336968e-01
-404, 4.571564e-02, -2.025045e-02, 2.440315e-01
-405, 4.487920e-02, -2.204217e-02, 2.545445e-01
-406, 4.455680e-02, -2.268681e-02, 2.664580e-01
-407, 4.417746e-02, -2.341692e-02, 2.781064e-01
-408, 4.472961e-02, -2.234418e-02, 2.893368e-01
-409, 4.607850e-02, -1.941062e-02, 2.995941e-01
-410, 4.471424e-02, -2.237492e-02, 3.098914e-01
-411, 4.410124e-02, -2.356014e-02, 3.211930e-01
-412, 4.429652e-02, -2.319090e-02, 3.328627e-01
-413, 4.551547e-02, -2.069643e-02, 3.435265e-01
-414, 4.392076e-02, -2.389491e-02, 3.538697e-01
-415, 4.334501e-02, -2.492409e-02, 3.655056e-01
-416, 4.337123e-02, -2.487844e-02, 3.775447e-01
-417, 4.373459e-02, -2.423398e-02, 3.894987e-01
-418, 4.457761e-02, -2.264590e-02, 4.008021e-01
-419, 4.601051e-02, -1.957123e-02, 4.111240e-01
-420, 4.461196e-02, -2.257815e-02, 4.217105e-01
-421, 4.390409e-02, -2.392553e-02, 4.333676e-01
-422, 4.424608e-02, -2.328700e-02, 4.454089e-01
-423, 4.510092e-02, -2.158488e-02, 4.573769e-01
-424, 4.590942e-02, -1.980720e-02, 4.694210e-01
-425, 4.686265e-02, -1.743249e-02, 4.807080e-01
-426, 4.258428e-02, 2.620265e-02, 2.059631e-02
-427, 3.567210e-02, 3.503572e-02, 2.097387e-02
-428, 2.723833e-02, 4.192939e-02, 1.961752e-02
-429, 1.700895e-02, 4.701803e-02, 1.897116e-02
-430, 6.196541e-03, 4.961454e-02, 2.064173e-02
-431, -4.242089e-03, 4.981972e-02, 2.280365e-02
-432, -1.473415e-02, 4.777975e-02, 2.279240e-02
-433, -2.405737e-02, 4.383199e-02, 1.998018e-02
-434, -3.226563e-02, 3.819593e-02, 2.250558e-02
-435, -3.986126e-02, 3.018410e-02, 2.236610e-02
-436, -4.514389e-02, 2.149486e-02, 1.972670e-02
-437, -4.844630e-02, 1.236753e-02, 2.226222e-02
-438, -4.997543e-02, 1.567235e-03, 2.257815e-02
-439, -4.904738e-02, -9.713635e-03, 2.249860e-02
-440, -4.570193e-02, -2.028136e-02, 2.226095e-02
-441, -4.045805e-02, -2.937935e-02, 2.195945e-02
-442, -3.405171e-02, -3.661258e-02, 1.924157e-02
-443, -2.632523e-02, -4.250861e-02, 2.115109e-02
-444, -1.610646e-02, -4.733479e-02, 2.246302e-02
-445, -5.147307e-03, -4.973435e-02, 2.396971e-02
-446, 6.191572e-03, -4.961516e-02, 2.389788e-02
-447, 1.712202e-02, -4.697698e-02, 2.271966e-02
-448, 2.566878e-02, -4.290820e-02, 1.845748e-02
-449, 3.347650e-02, -3.713925e-02, 1.894567e-02
-450, 4.051253e-02, -2.930417e-02, 2.327400e-02
-451, 4.462817e-02, 2.254609e-02, 8.030191e-02
-452, 4.543581e-02, 2.087073e-02, 4.284340e-02
-453, 4.489829e-02, 2.200326e-02, 5.500859e-02
-454, 4.687416e-02, 1.740152e-02, 4.784662e-01
-455, 4.441377e-02, 2.296555e-02, 1.102052e-01
-456, 4.649228e-02, 1.839748e-02, 3.096402e-02
-457, 4.543118e-02, 2.088080e-02, 1.332471e-01
-458, 4.621789e-02, 1.907633e-02, 9.970946e-02
-459, 4.445054e-02, 2.289430e-02, 1.571663e-01
-460, 4.416989e-02, 2.343120e-02, 1.223746e-01
-461, 4.635623e-02, 1.873766e-02, 1.826082e-01
-462, 4.514560e-02, 2.149128e-02, 2.062237e-01
-463, 4.501271e-02, 2.176823e-02, 2.211934e-01
-464, 4.404475e-02, 2.366559e-02, 2.474488e-01
-465, 4.581647e-02, 2.002127e-02, 2.606299e-01
-466, 4.568706e-02, 2.031483e-02, 2.838772e-01
-467, 4.426885e-02, 2.324368e-02, 2.969898e-01
-468, 4.465887e-02, 2.248522e-02, 3.235887e-01
-469, 4.612771e-02, 1.929338e-02, 3.371136e-01
-470, 4.487053e-02, 2.205982e-02, 3.616778e-01
-471, 4.450568e-02, 2.278694e-02, 3.777346e-01
-472, 4.501660e-02, 2.176018e-02, 4.081471e-01
-473, 4.506965e-02, 2.165010e-02, 4.275186e-01
-474, 4.475252e-02, 2.229825e-02, 4.458503e-01
-475, 4.609833e-02, 1.936347e-02, 4.632317e-01
-476, -3.598477e-02, 3.471450e-02, 4.764289e-01
-477, -1.667937e-02, 4.713596e-02, 4.745266e-01
-478, 3.394277e-02, 3.671360e-02, 4.775224e-01
-479, -4.592780e-02, 1.976454e-02, 4.810768e-01
-480, -5.000000e-02, 5.045293e-06, 4.758111e-01
-481, -4.507381e-02, -2.164144e-02, 4.785019e-01
-482, -3.268129e-02, -3.784090e-02, 4.809578e-01
-483, -3.276021e-03, -4.989256e-02, 4.762814e-01
-484, 1.688043e-02, -4.706433e-02, 4.814902e-01
-485, 3.471675e-02, -3.598259e-02, 4.789036e-01
-486, 4.177515e-02, 2.747430e-02, 3.479511e-01
-487, 4.148995e-02, 2.790312e-02, 2.725148e-01
-488, 4.198824e-02, 2.714752e-02, 1.935977e-01
-489, 4.443385e-02, 2.292669e-02, 2.348799e-01
-490, 4.391428e-02, 2.390682e-02, 3.105669e-01
-491, 4.401567e-02, 2.371962e-02, 3.923877e-01
-492, 3.874706e-02, 3.160166e-02, 1.791246e-01
-493, 6.349864e-03, -4.959515e-02, 4.628959e-01
-494, -3.299916e-02, -3.756402e-02, 4.670205e-01
-495, 3.911401e-02, -3.114634e-02, 4.052415e-02
-496, -4.418977e-02, 2.339368e-02, 4.675431e-01
-497, 3.745628e-02, 3.312140e-02, 4.595562e-01
-498, 3.353286e-02, 3.708837e-02, 1.146519e-01
-499, 3.707937e-02, -3.354281e-02, 5.703076e-02
-500, 3.816715e-02, -3.229967e-02, 6.997792e-02
-501, 3.551817e-02, -3.519175e-02, 8.250541e-02
-502, 3.563497e-02, -3.507348e-02, 9.653299e-02
-503, 3.881867e-02, -3.151366e-02, 1.099266e-01
-504, 3.451675e-02, -3.617449e-02, 1.227166e-01
-505, 3.260305e-02, -3.790833e-02, 1.372137e-01
-506, 3.760126e-02, -3.295671e-02, 1.494909e-01
-507, 3.649355e-02, -3.417925e-02, 1.610461e-01
-508, 3.772215e-02, -3.281827e-02, 1.724803e-01
-509, 3.464070e-02, -3.605582e-02, 1.835292e-01
-510, 3.341968e-02, -3.719039e-02, 1.969457e-01
-511, 3.341202e-02, -3.719727e-02, 2.114061e-01
-512, 3.559595e-02, -3.511308e-02, 2.268811e-01
-513, 3.661340e-02, -3.405083e-02, 2.440571e-01
-514, 3.792864e-02, -3.257941e-02, 2.589296e-01
-515, 3.529003e-02, -3.542053e-02, 2.721310e-01
-516, 3.516345e-02, -3.554619e-02, 2.863807e-01
-517, 3.875021e-02, -3.159781e-02, 2.995358e-01
-518, 3.516644e-02, -3.554323e-02, 3.126580e-01
-519, 3.536245e-02, -3.534822e-02, 3.271244e-01
-520, 3.640127e-02, -3.427751e-02, 3.423702e-01
-521, 3.339813e-02, -3.720975e-02, 3.567105e-01
-522, 3.325911e-02, -3.733406e-02, 3.706806e-01
-523, 3.394614e-02, -3.671048e-02, 3.848976e-01
-524, 3.478356e-02, -3.591801e-02, 3.989164e-01
-525, 3.863171e-02, -3.174258e-02, 4.117614e-01
-526, 3.491606e-02, -3.578923e-02, 4.254123e-01
-527, 3.454987e-02, -3.614286e-02, 4.401459e-01
-528, 3.689699e-02, -3.374332e-02, 4.540966e-01
-529, 3.965319e-02, -3.045692e-02, 4.671178e-01
-530, 3.554036e-02, 3.516934e-02, 1.325835e-01
-531, 3.180413e-02, 3.858105e-02, 3.373833e-02
-532, 2.283943e-02, 4.447877e-02, 2.965262e-02
-533, 1.305536e-02, 4.826549e-02, 3.043402e-02
-534, 3.430182e-03, 4.988220e-02, 3.618717e-02
-535, -9.343112e-03, 4.911931e-02, 3.842737e-02
-536, -2.295260e-02, 4.442047e-02, 3.503339e-02
-537, -3.556557e-02, 3.514385e-02, 3.586544e-02
-538, -4.450534e-02, 2.278760e-02, 3.472221e-02
-539, -4.898116e-02, 1.004223e-02, 3.644344e-02
-540, -4.991600e-02, -2.897030e-03, 3.556761e-02
-541, -4.752296e-02, -1.554246e-02, 3.595412e-02
-542, -4.223092e-02, -2.676844e-02, 3.693347e-02
-543, -3.418916e-02, -3.648426e-02, 3.405670e-02
-544, -2.373565e-02, -4.400703e-02, 3.322689e-02
-545, -1.277616e-02, -4.834015e-02, 3.853253e-02
-546, 9.992658e-04, -4.999001e-02, 4.078933e-02
-547, 1.502794e-02, -4.768816e-02, 3.799484e-02
-548, 2.905288e-02, -4.069313e-02, 3.189406e-02
-549, -4.907982e-02, 9.548345e-03, 4.607884e-01
-550, 3.603024e-02, 3.466730e-02, 2.865214e-01
-551, 3.658004e-02, 3.408666e-02, 3.709880e-01
-552, 3.126451e-02, 3.901962e-02, 2.420114e-01
-553, 3.568436e-02, 3.502323e-02, 2.582545e-01
-554, 3.526195e-02, 3.544848e-02, 4.199283e-01
-555, 3.792336e-02, 3.258556e-02, 2.151003e-01
-556, 3.489324e-02, 3.581148e-02, 3.185639e-01
-557, 3.781032e-02, 3.271666e-02, 3.328985e-01
-558, 3.580087e-02, 3.490413e-02, 4.381020e-01
-559, 3.268912e-02, 3.783413e-02, 3.027051e-01
-560, 3.457912e-02, 3.611488e-02, 4.019779e-01
-561, 3.410007e-02, 3.656754e-02, 3.855850e-01
-562, -4.104734e-02, -2.855023e-02, 4.680988e-01
-563, 2.606558e-02, 4.266832e-02, 4.672446e-01
-564, 3.697389e-02, 3.365905e-02, 2.277415e-01
-565, -4.652278e-02, -1.832024e-02, 4.632888e-01
-566, 3.664845e-02, 3.401310e-02, 1.654916e-01
-567, 3.446037e-02, 3.622821e-02, 1.499497e-01
-568, 1.805382e-02, -4.662681e-02, 4.689679e-01
-569, 4.068251e-02, 2.906774e-02, 3.358290e-02
-570, -9.745261e-03, 4.904110e-02, 4.594590e-01
-571, -2.149619e-02, -4.514326e-02, 4.617540e-01
-572, -7.558889e-03, -4.942533e-02, 4.603091e-01
-573, 1.609088e-03, 4.997410e-02, 4.646684e-01
-574, 3.604619e-02, 3.465072e-02, 4.833782e-02
-575, 1.421497e-02, 4.793678e-02, 4.635794e-01
-576, 3.329088e-02, 3.730572e-02, 3.582229e-01
-577, -4.972188e-02, -5.266384e-03, 4.604653e-01
-578, 3.494063e-02, 3.576524e-02, 7.742770e-02
-579, 3.338239e-02, 3.722387e-02, 2.041962e-01
-580, -3.555110e-02, 3.515849e-02, 4.598139e-01
-581, -4.998135e-02, 1.365580e-03, 4.415195e-01
-582, 3.763069e-02, 3.292311e-02, 9.530102e-02
-583, -2.976551e-02, -4.017480e-02, 4.452954e-01
-584, 2.953531e-02, -4.034434e-02, 4.660052e-01
-585, 1.943295e-02, 4.606908e-02, 4.308677e-01
-586, 1.779493e-02, 4.672623e-02, 1.428277e-01
-587, 2.082077e-02, -4.545872e-02, 8.927346e-02
-588, 1.754667e-02, -4.682002e-02, 1.260193e-01
-589, 1.406938e-02, -4.797971e-02, 1.414428e-01
-590, 1.603811e-02, -4.735799e-02, 2.230989e-01
-591, 2.113700e-02, -4.531255e-02, 2.984536e-01
-592, 2.277412e-02, -4.451224e-02, 3.329764e-01
-593, 1.384783e-02, -4.804412e-02, 3.633183e-01
-594, 1.894102e-02, -4.627351e-02, 3.785925e-01
-595, 1.889532e-02, -4.629219e-02, 4.322344e-01
-596, 2.109376e-02, -4.533270e-02, 4.519330e-01
-597, 1.867807e-02, 4.638027e-02, 4.113700e-01
-598, -2.339103e-02, 4.419117e-02, 4.578921e-01
-599, 3.708308e-02, 3.353871e-02, 6.220323e-02
-600, 1.604857e-02, 4.735444e-02, 2.564287e-01
-601, 2.550732e-02, -4.300438e-02, 4.974312e-02
-602, 2.863694e-02, 4.098690e-02, 3.436206e-01
-603, 2.399405e-02, 4.386668e-02, 4.503806e-01
-604, 2.443731e-02, 4.362130e-02, 2.736482e-01
-605, 2.234301e-02, 4.473019e-02, 3.284533e-01
-606, 2.941968e-02, 4.042873e-02, 1.908238e-01
-607, -3.191144e-02, 3.849233e-02, 4.398890e-01
-608, 1.572792e-02, 4.746191e-02, 1.244784e-01
-609, 2.455580e-02, -4.355471e-02, 6.898868e-02
-610, -1.407054e-02, 4.797937e-02, 4.400164e-01
-611, -4.722795e-02, -1.641709e-02, 4.440103e-01
-612, -1.411230e-02, -4.796710e-02, 4.416697e-01
-613, 1.982045e-02, 4.590370e-02, 4.587756e-02
-614, 1.214220e-02, 4.850327e-02, 2.927073e-01
-615, 4.020736e-03, -4.983807e-02, 4.437211e-01
-616, 4.508685e-03, 4.979630e-02, 4.456017e-01
-617, 1.738071e-02, 4.688188e-02, 1.048345e-01
-618, 1.871680e-02, 4.636466e-02, 3.727859e-01
-619, 2.535122e-02, 4.309658e-02, 1.754604e-01
-620, 2.178991e-02, -4.500222e-02, 1.076285e-01
-621, 2.447791e-02, -4.359853e-02, 1.533527e-01
-622, 2.262054e-02, -4.459048e-02, 1.703947e-01
-623, 1.855669e-02, -4.642897e-02, 1.876729e-01
-624, 1.693182e-02, -4.704587e-02, 2.050568e-01
-625, 1.512503e-02, -4.765746e-02, 2.426996e-01
-626, 2.414287e-02, -4.378495e-02, 2.593774e-01
-627, 1.959000e-02, -4.600252e-02, 2.785979e-01
-628, 1.904253e-02, -4.623183e-02, 3.169720e-01
-629, 1.676843e-02, -4.710435e-02, 3.468486e-01
-630, 1.820901e-02, -4.656642e-02, 3.942835e-01
-631, 2.121133e-02, -4.527780e-02, 4.130218e-01
-632, 3.529718e-03, 4.987526e-02, 5.382920e-02
-633, -1.446008e-02, 4.786341e-02, 5.724978e-02
-634, -2.815159e-02, 4.132176e-02, 5.010911e-02
-635, -3.932843e-02, 3.087514e-02, 5.254239e-02
-636, -4.675664e-02, 1.771487e-02, 5.355687e-02
-637, -4.985470e-02, 3.809060e-03, 5.310735e-02
-638, -4.914960e-02, -9.182436e-03, 4.983939e-02
-639, -4.520876e-02, -2.135809e-02, 5.478065e-02
-640, -3.701511e-02, -3.361371e-02, 5.466244e-02
-641, -2.509169e-02, -4.324820e-02, 4.948906e-02
-642, -1.102142e-02, -4.877016e-02, 5.670650e-02
-643, 7.865385e-03, -4.937748e-02, 5.855908e-02
-644, 2.203254e-02, 4.488393e-02, 6.401500e-02
-645, 5.866139e-03, 4.965469e-02, 2.375700e-01
-646, 1.937581e-02, 4.609314e-02, 8.522369e-02
-647, 2.177195e-02, 4.501091e-02, 2.220142e-01
-648, 1.543404e-02, 4.755829e-02, 3.125591e-01
-649, -4.029859e-02, -2.959770e-02, 4.516524e-01
-650, 1.827928e-02, 4.653889e-02, 3.917804e-01
-651, -4.487468e-02, 2.205138e-02, 4.441819e-01
-652, 2.034669e-02, 4.567288e-02, 1.601610e-01
-653, -3.962241e-02, -3.049696e-02, 4.317275e-01
-654, -7.668944e-03, 4.940837e-02, 1.168598e-01
-655, 2.121121e-03, 4.995499e-02, 7.289676e-02
-656, -1.460935e-03, 4.997865e-02, 9.410347e-02
-657, 2.760196e-04, 4.999924e-02, 2.739992e-01
-658, 1.761476e-02, 4.679445e-02, 3.561837e-01
-659, -7.600352e-03, 4.941897e-02, 2.174414e-01
-660, 1.450591e-02, 4.784954e-02, 2.049071e-01
-661, -6.036205e-03, 4.963430e-02, 2.548831e-01
-662, -4.137931e-02, 2.806693e-02, 4.214718e-01
-663, 8.269504e-03, -4.931141e-02, 7.812952e-02
-664, -1.706180e-03, -4.997088e-02, 4.228660e-01
-665, -1.796533e-04, 4.999968e-02, 1.572401e-01
-666, -2.269114e-03, 4.994848e-02, 4.213875e-01
-667, 2.237273e-03, 4.994992e-02, 4.006964e-01
-668, -9.126508e-03, 4.916001e-02, 3.113426e-01
-669, -2.467899e-02, -4.348503e-02, 4.241030e-01
-670, -3.038463e-03, 4.990759e-02, 1.378777e-01
-671, -8.137025e-03, -4.933345e-02, 3.514558e-01
-672, -1.239885e-03, -4.998462e-02, 9.628506e-02
-673, -1.838323e-03, -4.996619e-02, 2.862180e-01
-674, 2.759107e-03, -4.992382e-02, 3.304174e-01
-675, -1.731899e-02, 4.690472e-02, 2.910430e-01
-676, -4.804429e-02, -1.384723e-02, 4.231587e-01
-677, 1.147478e-02, 4.866548e-02, 3.422931e-01
-678, -2.763434e-02, -4.166945e-02, 6.935520e-02
-679, -1.048070e-02, -4.888921e-02, 7.675017e-02
-680, 3.871706e-03, -4.984987e-02, 2.649232e-01
-681, -1.715952e-02, 4.696329e-02, 8.013368e-02
-682, -2.044218e-02, 4.563022e-02, 2.399381e-01
-683, -3.864193e-03, -4.985046e-02, 2.133571e-01
-684, -1.293697e-03, 4.998326e-02, 3.302654e-01
-685, -2.702254e-03, 4.992692e-02, 3.802970e-01
-686, 2.895749e-03, -4.991608e-02, 4.030727e-01
-687, 1.386618e-02, 4.803883e-02, 1.880673e-01
-688, 2.238040e-03, -4.994989e-02, 1.153496e-01
-689, -5.219881e-03, -4.972678e-02, 1.342901e-01
-690, -2.016618e-03, -4.995932e-02, 3.082940e-01
-691, 2.982206e-03, -4.991099e-02, 1.569176e-01
-692, 2.537928e-03, -4.993555e-02, 1.761383e-01
-693, -4.642497e-05, -4.999998e-02, 1.952468e-01
-694, -6.600747e-03, -4.956239e-02, 2.322198e-01
-695, -8.804523e-03, -4.921870e-02, 2.510156e-01
-696, -4.719570e-03, -4.977676e-02, 3.805499e-01
-697, -3.886901e-02, -3.145156e-02, 4.068685e-01
-698, -4.724330e-03, 4.977631e-02, 3.569154e-01
-699, -2.336643e-02, -4.420419e-02, 2.960646e-01
-700, -1.893558e-02, -4.627574e-02, 1.146990e-01
-701, -2.237728e-02, -4.471306e-02, 2.692344e-01
-702, -2.692072e-02, -4.213401e-02, 2.211539e-01
-703, -2.724321e-02, 4.192622e-02, 3.713455e-01
-704, -1.725699e-02, 4.692757e-02, 3.984434e-01
-705, -2.995314e-02, 4.003510e-02, 6.693386e-02
-706, -4.253871e-02, 2.627656e-02, 7.034731e-02
-707, -4.913375e-02, 9.266877e-03, 7.013782e-02
-708, -4.923425e-02, -8.717139e-03, 6.702797e-02
-709, -4.270962e-02, -2.599785e-02, 7.666904e-02
-710, -2.892627e-02, -4.078322e-02, 9.342562e-02
-711, -2.178715e-02, 4.500355e-02, 1.558457e-01
-712, -2.263993e-02, 4.458064e-02, 1.355308e-01
-713, -2.936878e-02, -4.046572e-02, 3.445262e-01
-714, 5.508695e-03, 4.969562e-02, 1.744227e-01
-715, -2.741972e-02, 4.181099e-02, 2.672612e-01
-716, -4.937642e-02, 7.872056e-03, 4.217893e-01
-717, -2.466331e-02, 4.349392e-02, 4.198639e-01
-718, -4.736402e-02, 1.602029e-02, 4.010523e-01
-719, -4.934338e-02, -8.076578e-03, 4.013137e-01
-720, -2.326053e-02, 4.426000e-02, 1.010452e-01
-721, -2.675295e-02, 4.224073e-02, 3.373644e-01
-722, -4.031640e-03, 4.983719e-02, 1.936893e-01
-723, -1.743304e-02, -4.686245e-02, 4.042964e-01
-724, -2.844023e-02, -4.112363e-02, 2.435802e-01
-725, -3.017940e-02, 3.986482e-02, 3.116600e-01
-726, -2.957179e-02, -4.031761e-02, 1.352573e-01
-727, -3.292232e-02, 3.763138e-02, 1.218611e-01
-728, -2.621610e-02, 4.257600e-02, 1.978086e-01
-729, -2.869416e-02, -4.094686e-02, 3.877765e-01
-730, -3.539736e-02, 3.531327e-02, 3.992884e-01
-731, -1.544212e-02, 4.755566e-02, 1.760252e-01
-732, -2.790101e-02, -4.149137e-02, 3.663670e-01
-733, -3.436782e-02, 3.631601e-02, 2.208956e-01
-734, -4.620043e-02, -1.911858e-02, 1.001567e-01
-735, -4.420723e-02, -2.336066e-02, 3.800513e-01
-736, -4.582536e-02, 2.000092e-02, 3.548120e-01
-737, -4.137961e-02, 2.806649e-02, 2.455815e-01
-738, -4.605799e-02, 1.945923e-02, 3.219525e-01
-739, -4.067967e-02, 2.907172e-02, 1.477794e-01
-740, -2.178036e-02, -4.500684e-02, 3.232550e-01
-741, -1.826457e-02, -4.654466e-02, 1.499082e-01
-742, -4.574531e-02, -2.018332e-02, 2.287536e-01
-743, -2.142752e-02, -4.517589e-02, 2.014163e-01
-744, -4.284574e-02, -2.577290e-02, 2.565088e-01
-745, -3.894078e-02, -3.136264e-02, 1.176678e-01
-746, -3.461753e-02, 3.607806e-02, 8.595087e-02
-747, -4.678334e-02, 1.764423e-02, 8.780888e-02
-748, -4.984833e-02, -3.891481e-03, 8.576008e-02
-749, -1.768477e-02, -4.676803e-02, 1.680385e-01
-750, -4.020403e-02, 2.972602e-02, 2.924637e-01
-751, -4.136776e-02, -2.808396e-02, 2.824850e-01
-752, -4.125905e-02, 2.824341e-02, 1.050293e-01
-753, -4.118770e-02, -2.834738e-02, 3.068690e-01
-754, -3.673134e-02, -3.392357e-02, 1.598985e-01
-755, -1.455413e-02, -4.783490e-02, 1.851659e-01
-756, -4.304298e-02, -2.544212e-02, 3.545128e-01
-757, -3.634650e-02, 3.433558e-02, 1.750852e-01
-758, -3.251533e-02, -3.798360e-02, 1.831934e-01
-759, -4.985520e-02, 3.802510e-03, 3.801988e-01
-760, -4.051273e-02, -2.930390e-02, 2.041098e-01
-761, -4.964982e-02, 5.907242e-03, 1.051776e-01
-762, -4.323081e-02, 2.512165e-02, 3.802460e-01
-763, -4.497383e-02, -2.184845e-02, 1.400510e-01
-764, -4.453190e-02, 2.273566e-02, 1.992417e-01
-765, -4.942971e-02, -7.530163e-03, 1.228195e-01
-766, -4.206763e-02, -2.702434e-02, 3.307467e-01
-767, -4.988144e-02, -3.441144e-03, 3.400690e-01
-768, -4.912410e-02, 9.317896e-03, 1.738947e-01
-769, -4.665040e-02, 1.799277e-02, 2.703294e-01
-770, -4.967895e-02, -5.657048e-03, 3.621085e-01
-771, -4.999866e-02, 3.667389e-04, 2.949429e-01
-772, -4.998346e-02, 1.286071e-03, 2.482189e-01
-773, -4.677553e-02, 1.766493e-02, 1.253644e-01
-774, -4.856149e-02, 1.190721e-02, 2.243824e-01
-775, -4.988683e-02, -3.362126e-03, 2.025025e-01
-776, -4.985463e-02, 3.809953e-03, 1.453499e-01
-777, -4.827581e-02, -1.301716e-02, 1.606022e-01
-778, -4.946691e-02, -7.281818e-03, 2.709830e-01
-779, -4.938159e-02, -7.839554e-03, 3.181067e-01
-780, -4.634310e-02, -1.877012e-02, 1.818715e-01
-781, 5.844431e-02, 1.357432e-02, 4.905513e-01
-782, 5.501935e-02, 2.393473e-02, 4.901401e-01
-783, 4.999928e-02, 3.316734e-02, 4.896936e-01
-784, 4.351123e-02, 4.131311e-02, 4.895931e-01
-785, 3.581020e-02, 4.814176e-02, 4.901523e-01
-786, 2.668722e-02, 5.373818e-02, 4.901063e-01
-787, 1.742285e-02, 5.741467e-02, 4.894846e-01
-788, 7.125666e-03, 5.957537e-02, 4.896401e-01
-789, -3.319253e-03, 5.990812e-02, 4.898032e-01
-790, -1.353922e-02, 5.845245e-02, 4.897595e-01
-791, -2.350304e-02, 5.520514e-02, 4.892185e-01
-792, -3.270757e-02, 5.030124e-02, 4.890932e-01
-793, -4.061374e-02, 4.416474e-02, 4.892399e-01
-794, -4.748689e-02, 3.667418e-02, 4.900356e-01
-795, -5.302369e-02, 2.808003e-02, 4.902072e-01
-796, -5.698478e-02, 1.878123e-02, 4.896891e-01
-797, -5.931624e-02, 9.032351e-03, 4.899810e-01
-798, -5.998349e-02, -1.407527e-03, 4.898694e-01
-799, -5.891407e-02, -1.136363e-02, 4.892667e-01
-800, -5.615250e-02, -2.113993e-02, 4.893197e-01
-801, -5.176387e-02, -3.033978e-02, 4.895862e-01
-802, -4.579344e-02, -3.876803e-02, 4.896590e-01
-803, -3.850011e-02, -4.601893e-02, 4.894552e-01
-804, -3.024373e-02, -5.182004e-02, 4.893857e-01
-805, -2.101204e-02, -5.620048e-02, 4.893739e-01
-806, -1.123035e-02, -5.893962e-02, 4.893139e-01
-807, -1.415883e-03, -5.998329e-02, 4.895632e-01
-808, 8.791922e-03, -5.935236e-02, 4.894923e-01
-809, 1.844100e-02, -5.709579e-02, 4.892128e-01
-810, 2.733089e-02, -5.341369e-02, 4.901206e-01
-811, 3.591423e-02, -4.806421e-02, 4.907472e-01
-812, 4.344319e-02, -4.138465e-02, 4.904816e-01
-813, 4.943756e-02, -3.399894e-02, 4.911143e-01
-814, 5.438801e-02, -2.533663e-02, 4.911917e-01
-815, 5.758418e-02, -1.685414e-02, 4.913489e-01
-816, 5.950192e-02, -7.715024e-03, 4.911401e-01
-817, 5.950952e-02, -7.656187e-03, 1.786144e-02
-818, 5.909924e-02, -1.035761e-02, 3.910235e-02
-819, 5.903004e-02, -1.074500e-02, 6.155027e-02
-820, 5.901170e-02, -1.084523e-02, 8.399617e-02
-821, 5.930083e-02, -9.132972e-03, 1.054821e-01
-822, 5.923012e-02, -9.580864e-03, 1.276331e-01
-823, 5.862036e-02, -1.279272e-02, 1.498661e-01
-824, 5.888024e-02, -1.153762e-02, 1.734296e-01
-825, 5.907485e-02, -1.049582e-02, 1.939090e-01
-826, 5.864326e-02, -1.268732e-02, 2.145256e-01
-827, 5.861855e-02, -1.280098e-02, 2.383540e-01
-828, 5.929681e-02, -9.159035e-03, 2.606632e-01
-829, 5.928291e-02, -9.248629e-03, 2.828696e-01
-830, 5.866528e-02, -1.258509e-02, 3.047074e-01
-831, 5.885755e-02, -1.165283e-02, 3.279679e-01
-832, 5.854986e-02, -1.311160e-02, 3.495920e-01
-833, 5.887150e-02, -1.158218e-02, 3.712708e-01
-834, 5.871493e-02, -1.235138e-02, 3.949058e-01
-835, 5.885217e-02, -1.168001e-02, 4.163171e-01
-836, 5.881636e-02, -1.185900e-02, 4.375029e-01
-837, 5.930487e-02, -9.106727e-03, 4.603159e-01
-838, 5.970296e-02, -5.962960e-03, 4.818794e-01
-839, 5.855763e-02, 1.307686e-02, 9.359286e-03
-840, 4.982190e-02, 3.343319e-02, 1.119184e-02
-841, 3.442029e-02, 4.914513e-02, 1.198843e-02
-842, 1.675400e-02, 5.761340e-02, 8.340869e-03
-843, -2.858611e-03, 5.993186e-02, 1.182665e-02
-844, -2.358851e-02, 5.516867e-02, 1.244083e-02
-845, -4.021893e-02, 4.452458e-02, 8.597908e-03
-846, -5.320766e-02, 2.772985e-02, 1.402434e-02
-847, -5.938289e-02, 8.583265e-03, 1.316335e-02
-848, -5.880848e-02, -1.189802e-02, 9.131494e-03
-849, -5.278035e-02, -2.853480e-02, 1.269229e-02
-850, -3.922505e-02, -4.540259e-02, 1.241347e-02
-851, -2.083487e-02, -5.626640e-02, 1.207731e-02
-852, -2.014448e-03, -5.996617e-02, 1.228501e-02
-853, 1.885732e-02, -5.695965e-02, 1.298389e-02
-854, 3.717599e-02, -4.709507e-02, 1.063326e-02
-855, 4.965653e-02, -3.367831e-02, 1.039951e-02
-856, 5.849324e-02, -1.336194e-02, 9.137322e-03
-857, 5.953152e-02, 7.483162e-03, 1.764965e-02
-858, 5.937116e-02, 8.664031e-03, 2.746376e-02
-859, 5.921732e-02, 9.659689e-03, 3.838415e-02
-860, 5.917016e-02, 9.944459e-03, 4.971479e-02
-861, 5.908169e-02, 1.045726e-02, 6.083476e-02
-862, 5.906144e-02, 1.057099e-02, 7.203296e-02
-863, 5.907262e-02, 1.050834e-02, 8.335784e-02
-864, 5.915560e-02, 1.003072e-02, 9.423507e-02
-865, 5.916247e-02, 9.990117e-03, 1.053158e-01
-866, 5.910111e-02, 1.034694e-02, 1.167169e-01
-867, 5.905625e-02, 1.059994e-02, 1.278789e-01
-868, 5.900536e-02, 1.087966e-02, 1.386923e-01
-869, 5.902729e-02, 1.076008e-02, 1.497872e-01
-870, 5.906082e-02, 1.057446e-02, 1.610519e-01
-871, 5.912231e-02, 1.022510e-02, 1.719649e-01
-872, 5.910542e-02, 1.032228e-02, 1.831038e-01
-873, 5.906787e-02, 1.053504e-02, 1.943041e-01
-874, 5.910471e-02, 1.032636e-02, 2.055277e-01
-875, 5.908809e-02, 1.042100e-02, 2.165177e-01
-876, 5.906560e-02, 1.054776e-02, 2.276035e-01
-877, 5.905073e-02, 1.063065e-02, 2.388153e-01
-878, 5.912127e-02, 1.023111e-02, 2.495501e-01
-879, 5.913943e-02, 1.012559e-02, 2.606489e-01
-880, 5.911461e-02, 1.026953e-02, 2.719354e-01
-881, 5.912909e-02, 1.018579e-02, 2.830702e-01
-882, 5.911568e-02, 1.026336e-02, 2.939844e-01
-883, 5.910565e-02, 1.032097e-02, 3.050858e-01
-884, 5.909341e-02, 1.039082e-02, 3.163361e-01
-885, 5.911477e-02, 1.026859e-02, 3.272326e-01
-886, 5.905907e-02, 1.058427e-02, 3.384002e-01
-887, 5.900550e-02, 1.087890e-02, 3.496896e-01
-888, 5.907791e-02, 1.047859e-02, 3.605865e-01
-889, 5.908528e-02, 1.043693e-02, 3.717102e-01
-890, 5.911463e-02, 1.026940e-02, 3.828978e-01
-891, 5.911457e-02, 1.026972e-02, 3.942210e-01
-892, 5.916194e-02, 9.993261e-03, 4.051958e-01
-893, 5.909763e-02, 1.036676e-02, 4.166452e-01
-894, 5.910686e-02, 1.031403e-02, 4.276854e-01
-895, 5.906245e-02, 1.056538e-02, 4.389599e-01
-896, 5.912966e-02, 1.018249e-02, 4.503932e-01
-897, 5.921784e-02, 9.656464e-03, 4.616963e-01
-898, 5.932936e-02, 8.945760e-03, 4.724059e-01
-899, 5.951778e-02, 7.591724e-03, 4.820142e-01
-900, 5.924741e-02, -9.473334e-03, 2.799464e-02
-901, 5.905482e-02, -1.060791e-02, 5.022217e-02
-902, 5.899757e-02, -1.092183e-02, 7.248143e-02
-903, 5.898956e-02, -1.096504e-02, 9.508014e-02
-904, 5.855525e-02, -1.308750e-02, 1.163963e-01
-905, 5.880636e-02, -1.190848e-02, 1.381748e-01
-906, 5.864336e-02, -1.268685e-02, 1.618381e-01
-907, 5.943314e-02, -8.228096e-03, 1.834324e-01
-908, 5.923120e-02, -9.574168e-03, 2.045057e-01
-909, 5.854259e-02, -1.314401e-02, 2.263354e-01
-910, 5.887814e-02, -1.154834e-02, 2.500200e-01
-911, 5.862893e-02, -1.275337e-02, 2.717035e-01
-912, 5.888104e-02, -1.153355e-02, 2.932986e-01
-913, 5.866245e-02, -1.259830e-02, 3.164596e-01
-914, 5.926785e-02, -9.344636e-03, 3.385023e-01
-915, 5.925482e-02, -9.426862e-03, 3.606977e-01
-916, 5.867892e-02, -1.252135e-02, 3.829371e-01
-917, 5.919703e-02, -9.783223e-03, 4.055473e-01
-918, 5.921753e-02, -9.658391e-03, 4.270239e-01
-919, 5.895308e-02, -1.115952e-02, 4.492173e-01
-920, 5.870551e-02, -1.239607e-02, 4.712585e-01
-921, 5.513090e-02, 2.367665e-02, 1.007636e-02
-922, 4.280542e-02, 4.204398e-02, 1.179286e-02
-923, 2.528382e-02, 5.441258e-02, 1.105002e-02
-924, 7.634173e-03, 5.951235e-02, 1.085997e-02
-925, -1.358368e-02, 5.844214e-02, 1.239586e-02
-926, -3.266957e-02, 5.032593e-02, 1.052672e-02
-927, -4.697302e-02, 3.733009e-02, 1.479335e-02
-928, -5.706991e-02, 1.852094e-02, 1.105243e-02
-929, -5.995276e-02, -2.380529e-03, 1.256828e-02
-930, -5.647507e-02, -2.026243e-02, 9.089864e-03
-931, -4.679851e-02, -3.754863e-02, 1.323858e-02
-932, -3.026462e-02, -5.180784e-02, 1.212837e-02
-933, -1.157234e-02, -5.887343e-02, 9.903890e-03
-934, 8.526054e-03, -5.939113e-02, 1.300271e-02
-935, 2.841105e-02, -5.284707e-02, 1.185726e-02
-936, 4.380327e-02, -4.100333e-02, 8.466690e-03
-937, 5.499886e-02, -2.398176e-02, 1.009732e-02
-938, 5.351844e-02, 2.712520e-02, 4.792096e-01
-939, 4.751258e-02, 3.664089e-02, 4.784055e-01
-940, 3.996674e-02, 4.475109e-02, 4.783514e-01
-941, 3.186873e-02, 5.083683e-02, 4.804623e-01
-942, 2.329032e-02, 5.529522e-02, 4.778995e-01
-943, 1.311114e-02, 5.854996e-02, 4.775085e-01
-944, 2.450652e-03, 5.994993e-02, 4.784919e-01
-945, -8.495891e-03, 5.939545e-02, 4.786104e-01
-946, -1.876362e-02, 5.699058e-02, 4.776683e-01
-947, -2.851275e-02, 5.279227e-02, 4.770211e-01
-948, -3.743028e-02, 4.689322e-02, 4.767512e-01
-949, -4.502456e-02, 3.965840e-02, 4.775167e-01
-950, -5.066006e-02, 3.214900e-02, 4.801572e-01
-951, -5.518167e-02, 2.355808e-02, 4.785369e-01
-952, -5.845342e-02, 1.353504e-02, 4.782106e-01
-953, -5.986891e-02, 3.964086e-03, 4.799323e-01
-954, -5.974220e-02, -5.556065e-03, 4.772451e-01
-955, -5.789774e-02, -1.574330e-02, 4.776011e-01
-956, -5.416285e-02, -2.581445e-02, 4.780777e-01
-957, -4.906489e-02, -3.453457e-02, 4.785678e-01
-958, -4.225956e-02, -4.259260e-02, 4.783569e-01
-959, -3.450735e-02, -4.908404e-02, 4.775455e-01
-960, -2.567815e-02, -5.422760e-02, 4.780571e-01
-961, -1.562944e-02, -5.792858e-02, 4.779624e-01
-962, -5.506559e-03, -5.974678e-02, 4.772112e-01
-963, 4.045609e-03, -5.986345e-02, 4.791953e-01
-964, 1.383760e-02, -5.838254e-02, 4.766763e-01
-965, 2.396805e-02, -5.500484e-02, 4.770021e-01
-966, 3.230320e-02, -5.056188e-02, 4.805656e-01
-967, 4.003803e-02, -4.468732e-02, 4.795993e-01
-968, 4.711443e-02, -3.715145e-02, 4.798969e-01
-969, 5.216305e-02, -2.964820e-02, 4.821551e-01
-970, 5.609122e-02, -2.130200e-02, 4.805081e-01
-971, 5.847669e-02, -1.343416e-02, 4.834092e-01
-972, 4.705996e-02, 3.722043e-02, 2.352087e-02
-973, 5.602831e-02, -2.146692e-02, 1.040337e-01
-974, 5.478411e-02, -2.446838e-02, 6.717177e-02
-975, 5.494681e-02, -2.410079e-02, 9.055651e-02
-976, 5.604450e-02, -2.142460e-02, 5.590097e-02
-977, 5.582273e-02, -2.199598e-02, 7.863892e-02
-978, 5.566172e-02, -2.240028e-02, 1.279809e-01
-979, 5.296469e-02, -2.819117e-02, 1.565078e-01
-980, 5.410164e-02, -2.594249e-02, 1.712879e-01
-981, 5.629662e-02, -2.075308e-02, 1.849116e-01
-982, 5.505752e-02, -2.384680e-02, 2.009331e-01
-983, 5.306755e-02, -2.799706e-02, 2.316542e-01
-984, 5.420424e-02, -2.572742e-02, 2.457893e-01
-985, 5.602991e-02, -2.146273e-02, 2.594687e-01
-986, 5.601195e-02, -2.150957e-02, 2.833682e-01
-987, 5.357631e-02, -2.701072e-02, 3.102452e-01
-988, 5.415985e-02, -2.582074e-02, 3.240980e-01
-989, 5.584367e-02, -2.194275e-02, 3.376593e-01
-990, 5.584109e-02, -2.194932e-02, 3.615398e-01
-991, 5.395781e-02, -2.624033e-02, 3.902973e-01
-992, 5.481652e-02, -2.439568e-02, 4.069704e-01
-993, 5.500871e-02, -2.395917e-02, 4.259904e-01
-994, 5.600858e-02, -2.151833e-02, 4.579689e-01
-995, 4.661154e-03, 5.981867e-02, 2.512889e-02
-996, 2.695368e-02, 5.360503e-02, 2.526069e-02
-997, 5.537013e-02, -2.311165e-02, 4.448428e-02
-998, 1.627496e-02, 5.775055e-02, 2.049038e-02
-999, 5.358113e-02, 2.700116e-02, 2.170782e-02
-1000, -5.730560e-02, 1.777830e-02, 2.744483e-02
-1001, 3.778634e-02, 4.660678e-02, 2.551248e-02
-1002, -3.066505e-02, 5.157184e-02, 2.505195e-02
-1003, -5.803093e-02, -1.524505e-02, 2.329601e-02
-1004, -5.997702e-02, 1.660462e-03, 2.735691e-02
-1005, 5.765226e-02, 1.661978e-02, 1.989195e-02
-1006, -5.204508e-02, -2.985481e-02, 2.793583e-02
-1007, -3.473866e-02, -4.892060e-02, 2.468544e-02
-1008, -1.189962e-02, -5.880815e-02, 2.426455e-02
-1009, 2.648381e-02, -5.383872e-02, 2.701869e-02
-1010, 4.444722e-02, -4.030440e-02, 2.160897e-02
-1011, 5.221655e-02, -2.955388e-02, 2.193666e-02
-1012, 5.717193e-02, -1.820359e-02, 2.001684e-02
-1013, 5.759205e-02, 1.682723e-02, 4.805510e-01
-1014, 5.705337e-02, 1.857184e-02, 3.104199e-02
-1015, 5.654344e-02, 2.007087e-02, 4.241974e-02
-1016, 5.603150e-02, 2.145859e-02, 5.431887e-02
-1017, 5.575729e-02, 2.216134e-02, 6.608191e-02
-1018, 5.580032e-02, 2.205277e-02, 7.740574e-02
-1019, 5.588760e-02, 2.183064e-02, 8.886982e-02
-1020, 5.604252e-02, 2.142980e-02, 9.958416e-02
-1021, 5.620122e-02, 2.101008e-02, 1.108274e-01
-1022, 5.583519e-02, 2.196431e-02, 1.221215e-01
-1023, 5.531206e-02, 2.325030e-02, 1.329394e-01
-1024, 5.554973e-02, 2.267658e-02, 1.439596e-01
-1025, 5.571183e-02, 2.227538e-02, 1.554015e-01
-1026, 5.583071e-02, 2.197571e-02, 1.663237e-01
-1027, 5.587547e-02, 2.186166e-02, 1.776835e-01
-1028, 5.570184e-02, 2.230034e-02, 1.887490e-01
-1029, 5.590365e-02, 2.178949e-02, 1.998148e-01
-1030, 5.591011e-02, 2.177292e-02, 2.111716e-01
-1031, 5.584056e-02, 2.195067e-02, 2.219698e-01
-1032, 5.575478e-02, 2.216764e-02, 2.332794e-01
-1033, 5.560837e-02, 2.253239e-02, 2.441830e-01
-1034, 5.594727e-02, 2.167725e-02, 2.550857e-01
-1035, 5.606539e-02, 2.136989e-02, 2.664508e-01
-1036, 5.600413e-02, 2.152991e-02, 2.773234e-01
-1037, 5.597928e-02, 2.159445e-02, 2.884573e-01
-1038, 5.602348e-02, 2.147952e-02, 2.992287e-01
-1039, 5.596862e-02, 2.162207e-02, 3.105354e-01
-1040, 5.589722e-02, 2.180599e-02, 3.213856e-01
-1041, 5.573171e-02, 2.222558e-02, 3.326947e-01
-1042, 5.537044e-02, 2.311092e-02, 3.438718e-01
-1043, 5.539488e-02, 2.305227e-02, 3.551717e-01
-1044, 5.583830e-02, 2.195641e-02, 3.662185e-01
-1045, 5.596287e-02, 2.163694e-02, 3.776464e-01
-1046, 5.605898e-02, 2.138671e-02, 3.885268e-01
-1047, 5.606934e-02, 2.135953e-02, 3.998814e-01
-1048, 5.601998e-02, 2.148864e-02, 4.108311e-01
-1049, 5.589077e-02, 2.182252e-02, 4.224790e-01
-1050, 5.572926e-02, 2.223173e-02, 4.339977e-01
-1051, 5.586682e-02, 2.188374e-02, 4.459800e-01
-1052, 5.639727e-02, 2.047798e-02, 4.580409e-01
-1053, 5.698113e-02, 1.879230e-02, 4.694239e-01
-1054, -5.089277e-02, 3.177933e-02, 3.185615e-02
-1055, 5.217819e-02, -2.962156e-02, 3.495136e-01
-1056, 5.229291e-02, -2.941855e-02, 1.151919e-01
-1057, 5.292073e-02, -2.827360e-02, 2.711534e-01
-1058, 5.381830e-02, -2.652529e-02, 1.417200e-01
-1059, 5.324149e-02, -2.766484e-02, 2.162669e-01
-1060, 5.415374e-02, -2.583355e-02, 2.966426e-01
-1061, 5.428110e-02, -2.556486e-02, 3.753910e-01
-1062, 5.464619e-02, -2.477486e-02, 4.429735e-01
-1063, -7.386868e-03, 5.954355e-02, 2.479489e-02
-1064, -1.870123e-02, 5.701109e-02, 2.830266e-02
-1065, -4.124620e-02, 4.357466e-02, 3.294318e-02
-1066, -3.880456e-02, 4.576249e-02, 1.905728e-02
-1067, -2.449301e-02, -5.477310e-02, 2.666797e-02
-1068, -4.354440e-02, -4.127814e-02, 2.781546e-02
-1069, 1.714637e-03, -5.997550e-02, 2.656333e-02
-1070, 1.457606e-02, -5.820256e-02, 2.789671e-02
-1071, 3.558153e-02, -4.831102e-02, 2.262525e-02
-1072, 5.614186e-02, -2.116818e-02, 3.213287e-02
-1073, 4.417767e-02, 4.059967e-02, 4.655381e-01
-1074, 3.294257e-02, 5.014765e-02, 4.663361e-01
-1075, 2.101885e-02, 5.619794e-02, 4.636315e-01
-1076, 8.119870e-03, 5.944803e-02, 4.641455e-01
-1077, -2.718113e-03, 5.993840e-02, 4.670385e-01
-1078, -1.296216e-02, 5.858312e-02, 4.647194e-01
-1079, -2.363801e-02, 5.514748e-02, 4.632137e-01
-1080, -3.371522e-02, 4.963148e-02, 4.627872e-01
-1081, -4.366935e-02, 4.114593e-02, 4.630516e-01
-1082, -5.166152e-02, 3.051373e-02, 4.650680e-01
-1083, -5.722761e-02, 1.802778e-02, 4.657680e-01
-1084, -5.983268e-02, 4.477766e-03, 4.646329e-01
-1085, -5.926119e-02, -9.386741e-03, 4.621088e-01
-1086, -5.637824e-02, -2.053032e-02, 4.658823e-01
-1087, -5.168876e-02, -3.046755e-02, 4.639958e-01
-1088, -4.602163e-02, -3.849687e-02, 4.668464e-01
-1089, -3.912466e-02, -4.548913e-02, 4.635766e-01
-1090, -2.971073e-02, -5.212746e-02, 4.636432e-01
-1091, -2.025379e-02, -5.647817e-02, 4.664729e-01
-1092, -9.472794e-03, -5.924750e-02, 4.633359e-01
-1093, 4.719633e-03, -5.981409e-02, 4.634897e-01
-1094, 2.053099e-02, -5.637800e-02, 4.613377e-01
-1095, 3.413919e-02, -4.934081e-02, 4.659964e-01
-1096, 4.513313e-02, -3.953481e-02, 4.686769e-01
-1097, 5.285074e-02, -2.840422e-02, 4.695152e-01
-1098, 1.481494e-02, 5.814222e-02, 3.830095e-02
-1099, -5.585174e-02, -2.192221e-02, 4.789719e-02
-1100, 4.801593e-02, -3.597875e-02, 5.616727e-02
-1101, 4.149511e-02, -4.333769e-02, 3.003642e-01
-1102, 4.772601e-02, -3.636246e-02, 1.853076e-01
-1103, 4.410730e-02, -4.067612e-02, 3.801349e-01
-1104, 4.270804e-02, -4.214289e-02, 2.411633e-01
-1105, 4.767297e-02, -3.643197e-02, 2.853328e-01
-1106, 4.767509e-02, -3.642919e-02, 2.561135e-01
-1107, 4.219559e-02, -4.265598e-02, 1.671609e-01
-1108, 4.543415e-02, -3.918849e-02, 4.168471e-01
-1109, 4.707594e-02, -3.720022e-02, 3.348972e-01
-1110, 4.414170e-02, -4.063878e-02, 3.987128e-01
-1111, 4.718401e-02, -3.706304e-02, 3.641529e-01
-1112, -4.378499e-02, 4.102285e-02, 5.265849e-02
-1113, 4.297982e-02, -4.186568e-02, 2.025808e-01
-1114, 4.772278e-02, -3.636669e-02, 9.847111e-02
-1115, 5.214152e-02, 2.968606e-02, 4.671663e-01
-1116, 4.098438e-02, -4.382101e-02, 2.218654e-01
-1117, 5.117739e-02, 3.131892e-02, 4.663576e-02
-1118, 4.980950e-02, 3.345166e-02, 5.936942e-02
-1119, 4.843966e-02, 3.540620e-02, 7.185376e-02
-1120, 4.997738e-02, 3.320033e-02, 8.344732e-02
-1121, 4.865260e-02, 3.511303e-02, 9.494675e-02
-1122, 5.106105e-02, 3.150824e-02, 1.051569e-01
-1123, 5.070330e-02, 3.208077e-02, 1.152698e-01
-1124, 4.764137e-02, 3.647328e-02, 1.255947e-01
-1125, 4.730187e-02, 3.691251e-02, 1.383879e-01
-1126, 4.955541e-02, 3.382693e-02, 1.497455e-01
-1127, 4.821744e-02, 3.570825e-02, 1.609320e-01
-1128, 5.001564e-02, 3.314266e-02, 1.719187e-01
-1129, 4.865213e-02, 3.511367e-02, 1.829513e-01
-1130, 4.873758e-02, 3.499497e-02, 1.949477e-01
-1131, 5.021071e-02, 3.284638e-02, 2.057287e-01
-1132, 4.843455e-02, 3.541320e-02, 2.165875e-01
-1133, 4.989410e-02, 3.332535e-02, 2.275240e-01
-1134, 4.801564e-02, 3.597914e-02, 2.385412e-01
-1135, 4.880829e-02, 3.489629e-02, 2.506706e-01
-1136, 5.102656e-02, 3.156407e-02, 2.611959e-01
-1137, 4.959134e-02, 3.377423e-02, 2.720706e-01
-1138, 5.067465e-02, 3.212600e-02, 2.828740e-01
-1139, 4.942033e-02, 3.402398e-02, 2.936291e-01
-1140, 5.099042e-02, 3.162242e-02, 3.044541e-01
-1141, 4.899666e-02, 3.463131e-02, 3.149183e-01
-1142, 4.986066e-02, 3.337535e-02, 3.260088e-01
-1143, 4.812851e-02, 3.582801e-02, 3.367820e-01
-1144, 4.765800e-02, 3.645155e-02, 3.494734e-01
-1145, 4.816189e-02, 3.578313e-02, 3.619873e-01
-1146, 5.052062e-02, 3.236768e-02, 3.728577e-01
-1147, 4.946009e-02, 3.396616e-02, 3.836946e-01
-1148, 5.107693e-02, 3.148250e-02, 3.943038e-01
-1149, 4.949868e-02, 3.390990e-02, 4.051196e-01
-1150, 5.084026e-02, 3.186328e-02, 4.163274e-01
-1151, 4.904500e-02, 3.456282e-02, 4.276523e-01
-1152, 4.946112e-02, 3.396465e-02, 4.411609e-01
-1153, 5.070067e-02, 3.208491e-02, 4.543721e-01
-1154, 5.226335e-02, 2.947104e-02, 3.416630e-02
-1155, -2.682659e-02, 5.366875e-02, 4.806625e-02
-1156, 4.607417e-02, -3.843398e-02, 1.294648e-01
-1157, -4.844606e-03, 5.980410e-02, 4.425966e-02
-1158, 4.949371e-02, -3.391714e-02, 3.662753e-02
-1159, 4.724461e-02, -3.698576e-02, 4.536368e-01
-1160, 4.338580e-02, -4.144481e-02, 3.187059e-01
-1161, 4.420747e-02, 4.056722e-02, 3.707600e-02
-1162, 4.593725e-02, -3.859752e-02, 4.355009e-01
-1163, 4.703638e-02, -3.725022e-02, 7.846306e-02
-1164, -3.444317e-02, -4.912909e-02, 4.240099e-02
-1165, 2.384539e-02, -5.505813e-02, 4.619665e-02
-1166, -5.956821e-02, -7.185289e-03, 4.216132e-02
-1167, -5.397123e-03, -5.975677e-02, 4.089152e-02
-1168, -4.736657e-02, -3.682944e-02, 4.744776e-02
-1169, 8.591350e-03, -5.938172e-02, 4.575844e-02
-1170, -5.940101e-02, 8.456918e-03, 4.867433e-02
-1171, -5.460649e-02, 2.486225e-02, 5.112254e-02
-1172, -1.907226e-02, -5.688804e-02, 4.431418e-02
-1173, -3.339235e-02, 4.984928e-02, 7.238130e-02
-1174, 2.349334e-02, -5.520927e-02, 2.332918e-01
-1175, 2.861381e-02, 5.273756e-02, 4.473679e-01
-1176, -3.961017e-02, 4.506700e-02, 4.465876e-01
-1177, -5.752460e-02, 1.705639e-02, 4.458715e-01
-1178, -5.559949e-02, -2.255430e-02, 4.455829e-01
-1179, 2.676636e-02, -5.369881e-02, 1.830863e-01
-1180, 4.145715e-02, -4.337401e-02, 1.467899e-01
-1181, 2.331860e-02, -5.528330e-02, 2.086136e-01
-1182, 3.811369e-02, -4.633947e-02, 3.492164e-01
-1183, 3.804219e-02, -4.639819e-02, 4.015444e-02
-1184, 3.280797e-02, -5.023582e-02, 6.708936e-02
-1185, 3.033864e-02, -5.176453e-02, 3.323840e-01
-1186, -5.145760e-02, -3.085636e-02, 7.199421e-02
-1187, 4.185771e-02, -4.298759e-02, 2.698410e-01
-1188, 2.922340e-02, -5.240222e-02, 9.556004e-02
-1189, 3.043623e-02, 5.170721e-02, 4.396374e-02
-1190, 3.120269e-02, -5.124834e-02, 4.276798e-01
-1191, -8.730363e-03, 5.936144e-02, 7.297582e-02
-1192, -5.837111e-02, 1.388573e-02, 7.192095e-02
-1193, 2.276576e-02, -5.551324e-02, 1.548176e-01
-1194, 2.495266e-02, -5.456523e-02, 3.132650e-01
-1195, 1.629577e-02, 5.774468e-02, 6.411395e-02
-1196, 3.684446e-02, 4.735489e-02, 6.413410e-02
-1197, 3.368202e-02, 4.965402e-02, 1.297528e-01
-1198, 3.679278e-02, 4.739506e-02, 1.714395e-01
-1199, 3.711315e-02, 4.714461e-02, 2.065821e-01
-1200, 3.699995e-02, 4.723351e-02, 2.827224e-01
-1201, 3.520178e-02, 4.858842e-02, 3.228527e-01
-1202, 3.880298e-02, 4.576383e-02, 3.749061e-01
-1203, 3.967274e-02, 4.501193e-02, 4.149514e-01
-1204, 3.892777e-02, 4.565774e-02, 4.335862e-01
-1205, 4.136707e-02, 4.345993e-02, 4.512680e-01
-1206, 4.287741e-02, 4.197056e-02, 5.074894e-02
-1207, 1.350702e-02, 5.845990e-02, 4.459382e-01
-1208, -2.436273e-03, 5.995052e-02, 4.500143e-01
-1209, -1.659116e-02, 5.766050e-02, 4.496498e-01
-1210, -2.818173e-02, 5.296971e-02, 4.443422e-01
-1211, -4.955643e-02, 3.382544e-02, 4.433491e-01
-1212, -5.992042e-02, -3.089164e-03, 4.424317e-01
-1213, -4.666511e-02, -3.771429e-02, 4.500504e-01
-1214, -3.510700e-02, -4.865695e-02, 4.444059e-01
-1215, -2.066342e-02, -5.632959e-02, 4.508461e-01
-1216, -5.435168e-03, -5.975332e-02, 4.435806e-01
-1217, 1.354282e-02, -5.845162e-02, 4.403212e-01
-1218, 3.307587e-02, -5.005983e-02, 4.466176e-01
-1219, 2.628097e-02, -5.393803e-02, 3.867827e-01
-1220, -3.988554e-02, -4.482348e-02, 6.324289e-02
-1221, 2.849442e-02, -5.280216e-02, 4.071129e-01
-1222, 4.006259e-02, -4.466529e-02, 1.133182e-01
-1223, 2.805541e-02, -5.303672e-02, 2.569495e-01
-1224, 2.128770e-02, -5.609665e-02, 2.950264e-01
-1225, 3.687044e-02, 4.733466e-02, 8.408043e-02
-1226, 3.887695e-02, 4.570101e-02, 1.083365e-01
-1227, 3.608107e-02, 4.793909e-02, 1.507265e-01
-1228, 3.781244e-02, 4.658561e-02, 1.891441e-01
-1229, 3.531062e-02, 4.850938e-02, 2.461075e-01
-1230, 3.652453e-02, 4.760209e-02, 2.267351e-01
-1231, 4.057760e-02, 4.419795e-02, 2.628929e-01
-1232, 4.029644e-02, 4.445444e-02, 3.034704e-01
-1233, 3.625393e-02, 4.780850e-02, 3.410985e-01
-1234, 3.391328e-02, 4.949636e-02, 3.572099e-01
-1235, 4.002179e-02, 4.470186e-02, 3.948428e-01
-1236, -4.960456e-02, 3.375482e-02, 7.365087e-02
-1237, -2.441354e-02, -5.480857e-02, 6.506989e-02
-1238, 7.632272e-04, -5.999515e-02, 1.939967e-01
-1239, 2.570879e-02, -5.421308e-02, 1.270675e-01
-1240, -3.542745e-02, -4.842412e-02, 8.555554e-02
-1241, 3.113778e-03, -5.991915e-02, 2.485004e-01
-1242, 3.707479e-04, -5.999885e-02, 2.213373e-01
-1243, 3.036850e-02, -5.174702e-02, 3.667580e-01
-1244, 7.484064e-03, -5.953141e-02, 3.275035e-01
-1245, 3.088735e-02, -5.143901e-02, 2.804572e-01
-1246, -5.949660e-02, -7.755944e-03, 6.700064e-02
-1247, -2.431087e-02, 5.485419e-02, 9.223438e-02
-1248, 3.319778e-03, -5.990809e-02, 3.037714e-01
-1249, 1.445569e-02, -5.823258e-02, 6.198371e-02
-1250, -4.877276e-03, -5.980144e-02, 6.249656e-02
-1251, -5.471390e-04, -5.999751e-02, 1.657704e-01
-1252, -5.710600e-02, -1.840936e-02, 9.015421e-02
-1253, 1.632357e-04, -5.999978e-02, 1.366380e-01
-1254, 4.571813e-03, -5.982557e-02, 1.081362e-01
-1255, -5.996740e-02, 1.977486e-03, 9.376445e-02
-1256, -1.303980e-02, -5.856589e-02, 8.763922e-02
-1257, 1.633736e-02, 5.773293e-02, 9.115212e-02
-1258, 7.233775e-03, -5.956234e-02, 3.713545e-01
-1259, 4.113407e-03, -5.985883e-02, 3.976212e-01
-1260, 1.682159e-02, -5.759370e-02, 3.495500e-01
-1261, 1.445834e-02, 5.823192e-02, 2.400049e-01
-1262, 6.526128e-03, -5.964402e-02, 2.757381e-01
-1263, 2.196358e-02, 5.583548e-02, 4.257205e-01
-1264, 1.689012e-02, 5.757364e-02, 1.156193e-01
-1265, -4.178202e-02, 4.306115e-02, 9.597338e-02
-1266, -5.050590e-03, 5.978705e-02, 1.021880e-01
-1267, 9.875601e-03, 5.918169e-02, 3.192696e-01
-1268, 1.204150e-02, 5.877927e-02, 2.813338e-01
-1269, 1.081913e-02, -5.901649e-02, 8.270336e-02
-1270, -4.747771e-02, -3.668606e-02, 1.026281e-01
-1271, 1.443587e-02, 5.823749e-02, 1.635093e-01
-1272, 1.618810e-02, 5.777495e-02, 3.663974e-01
-1273, -5.526419e-02, 2.336384e-02, 9.616305e-02
-1274, 2.864986e-03, 5.993156e-02, 4.314144e-01
-1275, -1.595911e-02, 5.783863e-02, 4.286890e-01
-1276, -3.728301e-02, 4.701040e-02, 4.252850e-01
-1277, -1.065489e-02, -5.904637e-02, 3.473789e-01
-1278, -5.259547e-02, 2.887414e-02, 4.223457e-01
-1279, -5.948717e-02, 7.827949e-03, 4.216365e-01
-1280, -5.768693e-02, -1.649903e-02, 4.210322e-01
-1281, -4.467090e-02, -4.005635e-02, 4.230862e-01
-1282, -2.327599e-02, -5.530125e-02, 4.298148e-01
-1283, -4.252164e-03, -5.984914e-02, 4.219325e-01
-1284, 1.450520e-02, -5.822026e-02, 4.184976e-01
-1285, 1.449710e-02, 5.822228e-02, 2.156794e-01
-1286, 1.711476e-02, 5.750726e-02, 1.896080e-01
-1287, -8.737451e-03, 5.936040e-02, 1.769731e-01
-1288, 5.688765e-04, 5.999730e-02, 4.116310e-01
-1289, -2.521191e-02, -5.444593e-02, 1.147532e-01
-1290, 2.360283e-02, 5.516255e-02, 3.850074e-01
-1291, -5.568515e-02, 2.234198e-02, 3.995222e-01
-1292, 1.465750e-02, 5.818211e-02, 1.400611e-01
-1293, 2.144020e-02, 5.603854e-02, 4.039307e-01
-1294, -5.796147e-02, -1.550704e-02, 1.158914e-01
-1295, -5.372779e-02, -2.670813e-02, 3.956086e-01
-1296, 2.158333e-02, 5.598357e-02, 3.013310e-01
-1297, -2.575522e-02, -5.419104e-02, 1.489412e-01
-1298, -1.098441e-02, 5.898595e-02, 2.307289e-01
-1299, -1.668426e-02, -5.763363e-02, 3.178731e-01
-1300, -2.489157e-02, -5.459313e-02, 1.785650e-01
-1301, 2.187122e-02, 5.587173e-02, 2.624904e-01
-1302, -8.929997e-03, 5.933174e-02, 2.974318e-01
-1303, -7.988534e-03, 5.946582e-02, 2.619582e-01
-1304, -1.258491e-02, 5.866532e-02, 1.483905e-01
-1305, -9.682169e-03, 5.921364e-02, 2.031751e-01
-1306, -8.484815e-04, 5.999400e-02, 3.863447e-01
-1307, 1.516962e-02, 5.805069e-02, 3.419116e-01
-1308, -1.967291e-02, -5.668312e-02, 2.632889e-01
-1309, -1.948573e-02, -5.674774e-02, 3.786068e-01
-1310, -1.856907e-02, -5.705427e-02, 2.903750e-01
-1311, -2.169565e-02, -5.594014e-02, 2.355205e-01
-1312, -2.338191e-02, -5.525655e-02, 2.079432e-01
-1313, -1.290198e-02, 5.859641e-02, 3.296657e-01
-1314, -2.783948e-02, 5.315039e-02, 1.192827e-01
-1315, -3.906863e-03, 5.987267e-02, 1.257341e-01
-1316, -2.161713e-02, -5.597053e-02, 4.068604e-01
-1317, -8.855807e-03, 5.934286e-02, 3.579145e-01
-1318, -5.916483e-02, 9.976134e-03, 1.207536e-01
-1319, -4.306272e-02, -4.178040e-02, 2.230312e-01
-1320, -2.221339e-02, 5.573657e-02, 4.050342e-01
-1321, -3.477748e-02, 4.889301e-02, 2.777259e-01
-1322, -4.160327e-02, -4.323387e-02, 2.509449e-01
-1323, -3.853220e-02, -4.599206e-02, 3.963069e-01
-1324, -3.446448e-02, 4.911415e-02, 3.110292e-01
-1325, -5.998689e-02, -1.254388e-03, 3.991163e-01
-1326, -5.797724e-02, 1.544798e-02, 3.762753e-01
-1327, -4.910728e-02, 3.447426e-02, 1.208346e-01
-1328, -4.229724e-02, 4.255518e-02, 4.010216e-01
-1329, -4.691958e-02, -3.739723e-02, 1.637573e-01
-1330, -4.274172e-02, -4.210873e-02, 3.744513e-01
-1331, -3.524751e-02, 4.855526e-02, 3.462374e-01
-1332, -3.516596e-02, 4.861435e-02, 2.454523e-01
-1333, -3.582611e-02, -4.812993e-02, 3.316309e-01
-1334, -4.500160e-02, -3.968446e-02, 1.941964e-01
-1335, -2.749798e-02, 5.332786e-02, 3.782019e-01
-1336, -5.961670e-02, -6.771171e-03, 3.767631e-01
-1337, -2.916992e-02, 5.243201e-02, 1.657770e-01
-1338, -5.931282e-02, -9.054780e-03, 1.483116e-01
-1339, -4.061902e-02, -4.415988e-02, 2.782414e-01
-1340, -4.710818e-02, -3.715938e-02, 1.327506e-01
-1341, -3.400532e-02, 4.943317e-02, 2.154925e-01
-1342, -3.895479e-02, -4.563468e-02, 3.049554e-01
-1343, -5.418390e-02, -2.577024e-02, 3.712054e-01
-1344, -3.926833e-02, 4.536517e-02, 1.442104e-01
-1345, -3.276912e-02, -5.026116e-02, 3.557728e-01
-1346, -4.723139e-02, 3.700265e-02, 3.753198e-01
-1347, -3.177820e-02, 5.089348e-02, 1.887668e-01
-1348, -5.286204e-02, 2.838317e-02, 2.929389e-01
-1349, -5.230596e-02, 2.939534e-02, 2.250710e-01
-1350, -4.749695e-02, 3.666115e-02, 1.697815e-01
-1351, -5.583242e-02, 2.197137e-02, 1.469890e-01
-1352, -5.445134e-02, 2.520023e-02, 2.577059e-01
-1353, -5.132586e-02, 3.107501e-02, 3.230808e-01
-1354, -5.833959e-02, -1.401755e-02, 3.565280e-01
-1355, -5.333041e-02, 2.749305e-02, 3.517365e-01
-1356, -5.573125e-02, -2.222674e-02, 2.393081e-01
-1357, -4.989554e-02, -3.332319e-02, 3.481430e-01
-1358, -5.705570e-02, -1.856467e-02, 2.118667e-01
-1359, -5.813816e-02, -1.483086e-02, 1.820924e-01
-1360, -5.969374e-02, 6.054524e-03, 3.553624e-01
-1361, -5.296322e-02, -2.819393e-02, 3.199587e-01
-1362, -5.052895e-02, 3.235468e-02, 1.963863e-01
-1363, -5.506935e-02, -2.381947e-02, 2.664720e-01
-1364, -5.981070e-02, 4.762427e-03, 2.312714e-01
-1365, -5.855421e-02, 1.309214e-02, 1.742608e-01
-1366, -5.501513e-02, -2.394443e-02, 2.932369e-01
-1367, -5.994227e-02, 2.631321e-03, 3.097299e-01
-1368, -5.939537e-02, 8.496478e-03, 2.035522e-01
-1369, -5.916636e-02, -9.967063e-03, 3.353582e-01
-1370, -5.995471e-02, 2.330890e-03, 2.803599e-01
-1371, -5.860258e-02, 1.287393e-02, 3.339616e-01
-1372, -5.996790e-02, -1.962463e-03, 2.548954e-01
-1373, 5.447819e-02, -3.679030e-03, 2.938140e-01
-1374, 5.458275e-02, 3.286152e-03, 4.943852e-01
-1375, 5.476626e-02, 1.205782e-03, 5.799493e-03
-1376, 5.437623e-02, -3.558839e-03, 4.164568e-01
-1377, 5.434457e-02, -8.155921e-03, 3.221323e-01
-1378, 5.974720e-02, 5.501984e-03, 5.000000e-01
-1379, 5.783321e-02, 1.597872e-02, 5.000000e-01
-1380, 5.432824e-02, 2.546453e-02, 5.000000e-01
-1381, 4.938484e-02, 3.407547e-02, 5.000000e-01
-1382, 4.308904e-02, 4.175326e-02, 5.000000e-01
-1383, 3.539045e-02, 4.845117e-02, 5.000000e-01
-1384, 2.647879e-02, 5.384119e-02, 5.000000e-01
-1385, 1.703449e-02, 5.753109e-02, 5.000000e-01
-1386, 6.795028e-03, 5.961399e-02, 5.000000e-01
-1387, -3.650527e-03, 5.988884e-02, 5.000000e-01
-1388, -1.347719e-02, 5.846679e-02, 5.000000e-01
-1389, -2.316160e-02, 5.534926e-02, 5.000000e-01
-1390, -3.235816e-02, 5.052672e-02, 5.000000e-01
-1391, -4.040420e-02, 4.435652e-02, 5.000000e-01
-1392, -4.739369e-02, 3.679455e-02, 5.000000e-01
-1393, -5.303037e-02, 2.806742e-02, 5.000000e-01
-1394, -5.696204e-02, 1.885010e-02, 5.000000e-01
-1395, -5.930688e-02, 9.093630e-03, 5.000000e-01
-1396, -5.998274e-02, -1.439095e-03, 5.000000e-01
-1397, -5.882345e-02, -1.182376e-02, 5.000000e-01
-1398, -5.606809e-02, -2.136281e-02, 5.000000e-01
-1399, -5.176178e-02, -3.034334e-02, 5.000000e-01
-1400, -4.579199e-02, -3.876976e-02, 5.000000e-01
-1401, -3.848926e-02, -4.602800e-02, 5.000000e-01
-1402, -3.025402e-02, -5.181404e-02, 5.000000e-01
-1403, -2.112243e-02, -5.615909e-02, 5.000000e-01
-1404, -1.152443e-02, -5.888283e-02, 5.000000e-01
-1405, -1.655884e-03, -5.997715e-02, 5.000000e-01
-1406, 8.258002e-03, -5.942899e-02, 5.000000e-01
-1407, 1.794574e-02, -5.725339e-02, 5.000000e-01
-1408, 2.718913e-02, -5.348599e-02, 5.000000e-01
-1409, 3.580336e-02, -4.814685e-02, 5.000000e-01
-1410, 4.335959e-02, -4.147223e-02, 5.000000e-01
-1411, 4.976029e-02, -3.352482e-02, 5.000000e-01
-1412, 5.472167e-02, -2.460770e-02, 5.000000e-01
-1413, 5.809254e-02, -1.500854e-02, 5.000000e-01
-1414, 5.979371e-02, -4.971184e-03, 5.000000e-01
-1415, 6.000000e-02, -1.469576e-17, 5.890884e-03
-1416, 6.000000e-02, -1.469576e-17, 1.698279e-02
-1417, 6.000000e-02, -1.469576e-17, 2.755130e-02
-1418, 6.000000e-02, -1.469576e-17, 3.926259e-02
-1419, 6.000000e-02, -1.469576e-17, 5.058963e-02
-1420, 6.000000e-02, -1.469576e-17, 6.108357e-02
-1421, 6.000000e-02, -1.469576e-17, 7.212742e-02
-1422, 6.000000e-02, -1.469576e-17, 8.352902e-02
-1423, 6.000000e-02, -1.469576e-17, 9.460972e-02
-1424, 6.000000e-02, -1.469576e-17, 1.051894e-01
-1425, 6.000000e-02, -1.469576e-17, 1.168895e-01
-1426, 6.000000e-02, -1.469576e-17, 1.282053e-01
-1427, 6.000000e-02, -1.469576e-17, 1.386993e-01
-1428, 6.000000e-02, -1.469576e-17, 1.497656e-01
-1429, 6.000000e-02, -1.469576e-17, 1.611672e-01
-1430, 6.000000e-02, -1.469576e-17, 1.722367e-01
-1431, 6.000000e-02, -1.469576e-17, 1.828276e-01
-1432, 6.000000e-02, -1.469576e-17, 1.945164e-01
-1433, 6.000000e-02, -1.469576e-17, 2.058211e-01
-1434, 6.000000e-02, -1.469576e-17, 2.163150e-01
-1435, 6.000000e-02, -1.469576e-17, 2.274037e-01
-1436, 6.000000e-02, -1.469576e-17, 2.388053e-01
-1437, 6.000000e-02, -1.469576e-17, 2.498636e-01
-1438, 6.000000e-02, -1.469576e-17, 2.604657e-01
-1439, 6.000000e-02, -1.469576e-17, 2.721434e-01
-1440, 6.000000e-02, -1.469576e-17, 2.834368e-01
-1441, 6.000000e-02, -1.469576e-17, 2.939307e-01
-1442, 6.000000e-02, -1.469576e-17, 3.050418e-01
-1443, 6.000000e-02, -1.469576e-17, 3.164434e-01
-1444, 6.000000e-02, -1.469576e-17, 3.274905e-01
-1445, 6.000000e-02, -1.469576e-17, 3.381039e-01
-1446, 6.000000e-02, -1.469576e-17, 3.497703e-01
-1447, 6.000000e-02, -1.469576e-17, 3.610525e-01
-1448, 6.000000e-02, -1.469576e-17, 3.715464e-01
-1449, 6.000000e-02, -1.469576e-17, 3.826800e-01
-1450, 6.000000e-02, -1.469576e-17, 3.940816e-01
-1451, 6.000000e-02, -1.469576e-17, 4.051174e-01
-1452, 6.000000e-02, -1.469576e-17, 4.164492e-01
-1453, 6.000000e-02, -1.469576e-17, 4.275072e-01
-1454, 6.000000e-02, -1.469576e-17, 4.380011e-01
-1455, 6.000000e-02, -1.469576e-17, 4.495133e-01
-1456, 6.000000e-02, -1.469576e-17, 4.609149e-01
-1457, 6.000000e-02, -1.469576e-17, 4.717614e-01
-1458, 6.000000e-02, -1.469576e-17, 4.825269e-01
-1459, 6.000000e-02, -1.469576e-17, 4.939230e-01
-1460, 5.974874e-02, 5.485208e-03, 0.000000e+00
-1461, 5.784200e-02, 1.594687e-02, 0.000000e+00
-1462, 5.434170e-02, 2.543579e-02, 0.000000e+00
-1463, 4.940211e-02, 3.405042e-02, 0.000000e+00
-1464, 4.310929e-02, 4.173235e-02, 0.000000e+00
-1465, 3.541290e-02, 4.843476e-02, 0.000000e+00
-1466, 2.650257e-02, 5.382949e-02, 0.000000e+00
-1467, 1.705865e-02, 5.752393e-02, 0.000000e+00
-1468, 6.818760e-03, 5.961128e-02, 0.000000e+00
-1469, -3.627989e-03, 5.989021e-02, 0.000000e+00
-1470, -1.345646e-02, 5.847156e-02, 0.000000e+00
-1471, -2.314318e-02, 5.535696e-02, 0.000000e+00
-1472, -3.234245e-02, 5.053678e-02, 0.000000e+00
-1473, -4.039137e-02, 4.436820e-02, 0.000000e+00
-1474, -4.738385e-02, 3.680721e-02, 0.000000e+00
-1475, -5.302348e-02, 2.808044e-02, 0.000000e+00
-1476, -5.695782e-02, 1.886284e-02, 0.000000e+00
-1477, -5.930504e-02, 9.105607e-03, 0.000000e+00
-1478, -5.998300e-02, -1.428289e-03, 0.000000e+00
-1479, -5.882533e-02, -1.181444e-02, 0.000000e+00
-1480, -5.607100e-02, -2.135516e-02, 0.000000e+00
-1481, -5.176526e-02, -3.033740e-02, 0.000000e+00
-1482, -4.579559e-02, -3.876550e-02, 0.000000e+00
-1483, -3.849254e-02, -4.602526e-02, 0.000000e+00
-1484, -3.025677e-02, -5.181243e-02, 0.000000e+00
-1485, -2.112419e-02, -5.615842e-02, 0.000000e+00
-1486, -1.152477e-02, -5.888276e-02, 0.000000e+00
-1487, -1.654924e-03, -5.997717e-02, 0.000000e+00
-1488, 8.260249e-03, -5.942868e-02, 0.000000e+00
-1489, 1.794916e-02, -5.725232e-02, 0.000000e+00
-1490, 2.719349e-02, -5.348378e-02, 0.000000e+00
-1491, 3.580833e-02, -4.814316e-02, 0.000000e+00
-1492, 4.336478e-02, -4.146681e-02, 0.000000e+00
-1493, 4.976521e-02, -3.351751e-02, 0.000000e+00
-1494, 5.472582e-02, -2.459848e-02, 0.000000e+00
-1495, 5.809540e-02, -1.499748e-02, 0.000000e+00
-1496, 5.979421e-02, -4.965166e-03, 0.000000e+00
-1497, 4.974967e-02, 4.997062e-03, 5.000000e-01
-1498, 4.766671e-02, 1.509584e-02, 5.000000e-01
-1499, 4.338737e-02, 2.485027e-02, 5.000000e-01
-1500, 3.711768e-02, 3.350041e-02, 5.000000e-01
-1501, 2.943709e-02, 4.041606e-02, 5.000000e-01
-1502, 2.061528e-02, 4.555228e-02, 5.000000e-01
-1503, 1.040570e-02, 4.890523e-02, 5.000000e-01
-1504, -5.335747e-04, 4.999715e-02, 5.000000e-01
-1505, -1.114444e-02, 4.874219e-02, 5.000000e-01
-1506, -2.128922e-02, 4.524123e-02, 5.000000e-01
-1507, -3.044649e-02, 3.966120e-02, 5.000000e-01
-1508, -3.793855e-02, 3.256788e-02, 5.000000e-01
-1509, -4.370794e-02, 2.428201e-02, 5.000000e-01
-1510, -4.775167e-02, 1.482491e-02, 5.000000e-01
-1511, -4.981033e-02, 4.350947e-03, 5.000000e-01
-1512, -4.959594e-02, -6.343732e-03, 5.000000e-01
-1513, -4.713294e-02, -1.668790e-02, 5.000000e-01
-1514, -4.271109e-02, -2.599544e-02, 5.000000e-01
-1515, -3.669827e-02, -3.395934e-02, 5.000000e-01
-1516, -2.911649e-02, -4.064763e-02, 5.000000e-01
-1517, -1.986236e-02, -4.588558e-02, 5.000000e-01
-1518, -9.803373e-03, -4.902952e-02, 5.000000e-01
-1519, 1.781337e-04, -4.999968e-02, 5.000000e-01
-1520, 1.097304e-02, -4.878107e-02, 5.000000e-01
-1521, 2.176931e-02, -4.501219e-02, 5.000000e-01
-1522, 3.074063e-02, -3.943366e-02, 5.000000e-01
-1523, 3.795920e-02, -3.254381e-02, 5.000000e-01
-1524, 4.377258e-02, -2.416529e-02, 5.000000e-01
-1525, 4.776511e-02, -1.478155e-02, 5.000000e-01
-1526, 4.974981e-02, -4.995675e-03, 5.000000e-01
-1527, 4.974967e-02, 4.997062e-03, 0.000000e+00
-1528, 4.766671e-02, 1.509584e-02, 0.000000e+00
-1529, 4.338737e-02, 2.485027e-02, 0.000000e+00
-1530, 3.711768e-02, 3.350041e-02, 0.000000e+00
-1531, 2.943709e-02, 4.041606e-02, 0.000000e+00
-1532, 2.061528e-02, 4.555228e-02, 0.000000e+00
-1533, 1.040570e-02, 4.890523e-02, 0.000000e+00
-1534, -5.335747e-04, 4.999715e-02, 0.000000e+00
-1535, -1.114444e-02, 4.874219e-02, 0.000000e+00
-1536, -2.128922e-02, 4.524123e-02, 0.000000e+00
-1537, -3.044649e-02, 3.966120e-02, 0.000000e+00
-1538, -3.793855e-02, 3.256788e-02, 0.000000e+00
-1539, -4.370794e-02, 2.428201e-02, 0.000000e+00
-1540, -4.775167e-02, 1.482491e-02, 0.000000e+00
-1541, -4.981033e-02, 4.350947e-03, 0.000000e+00
-1542, -4.959594e-02, -6.343732e-03, 0.000000e+00
-1543, -4.713294e-02, -1.668790e-02, 0.000000e+00
-1544, -4.271109e-02, -2.599544e-02, 0.000000e+00
-1545, -3.669827e-02, -3.395934e-02, 0.000000e+00
-1546, -2.911649e-02, -4.064763e-02, 0.000000e+00
-1547, -1.986236e-02, -4.588558e-02, 0.000000e+00
-1548, -9.803373e-03, -4.902952e-02, 0.000000e+00
-1549, 1.781337e-04, -4.999968e-02, 0.000000e+00
-1550, 1.097304e-02, -4.878107e-02, 0.000000e+00
-1551, 2.176931e-02, -4.501219e-02, 0.000000e+00
-1552, 3.074063e-02, -3.943366e-02, 0.000000e+00
-1553, 3.795920e-02, -3.254381e-02, 0.000000e+00
-1554, 4.377258e-02, -2.416529e-02, 0.000000e+00
-1555, 4.776511e-02, -1.478155e-02, 0.000000e+00
-1556, 4.974981e-02, -4.995675e-03, 0.000000e+00
-1557, 5.000000e-02, -1.224647e-17, 5.890884e-03
-1558, 5.000000e-02, -1.224647e-17, 1.698279e-02
-1559, 5.000000e-02, -1.224647e-17, 2.755130e-02
-1560, 5.000000e-02, -1.224647e-17, 3.926259e-02
-1561, 5.000000e-02, -1.224647e-17, 5.058963e-02
-1562, 5.000000e-02, -1.224647e-17, 6.108357e-02
-1563, 5.000000e-02, -1.224647e-17, 7.212742e-02
-1564, 5.000000e-02, -1.224647e-17, 8.352902e-02
-1565, 5.000000e-02, -1.224647e-17, 9.460972e-02
-1566, 5.000000e-02, -1.224647e-17, 1.051894e-01
-1567, 5.000000e-02, -1.224647e-17, 1.168895e-01
-1568, 5.000000e-02, -1.224647e-17, 1.282053e-01
-1569, 5.000000e-02, -1.224647e-17, 1.386993e-01
-1570, 5.000000e-02, -1.224647e-17, 1.497656e-01
-1571, 5.000000e-02, -1.224647e-17, 1.611672e-01
-1572, 5.000000e-02, -1.224647e-17, 1.722367e-01
-1573, 5.000000e-02, -1.224647e-17, 1.828276e-01
-1574, 5.000000e-02, -1.224647e-17, 1.945164e-01
-1575, 5.000000e-02, -1.224647e-17, 2.058211e-01
-1576, 5.000000e-02, -1.224647e-17, 2.163150e-01
-1577, 5.000000e-02, -1.224647e-17, 2.274037e-01
-1578, 5.000000e-02, -1.224647e-17, 2.388053e-01
-1579, 5.000000e-02, -1.224647e-17, 2.498636e-01
-1580, 5.000000e-02, -1.224647e-17, 2.604657e-01
-1581, 5.000000e-02, -1.224647e-17, 2.721434e-01
-1582, 5.000000e-02, -1.224647e-17, 2.834368e-01
-1583, 5.000000e-02, -1.224647e-17, 2.939307e-01
-1584, 5.000000e-02, -1.224647e-17, 3.050418e-01
-1585, 5.000000e-02, -1.224647e-17, 3.164434e-01
-1586, 5.000000e-02, -1.224647e-17, 3.274905e-01
-1587, 5.000000e-02, -1.224647e-17, 3.381039e-01
-1588, 5.000000e-02, -1.224647e-17, 3.497703e-01
-1589, 5.000000e-02, -1.224647e-17, 3.610525e-01
-1590, 5.000000e-02, -1.224647e-17, 3.715464e-01
-1591, 5.000000e-02, -1.224647e-17, 3.826800e-01
-1592, 5.000000e-02, -1.224647e-17, 3.940816e-01
-1593, 5.000000e-02, -1.224647e-17, 4.051174e-01
-1594, 5.000000e-02, -1.224647e-17, 4.164492e-01
-1595, 5.000000e-02, -1.224647e-17, 4.275072e-01
-1596, 5.000000e-02, -1.224647e-17, 4.380011e-01
-1597, 5.000000e-02, -1.224647e-17, 4.495133e-01
-1598, 5.000000e-02, -1.224647e-17, 4.609149e-01
-1599, 5.000000e-02, -1.224647e-17, 4.717614e-01
-1600, 5.000000e-02, -1.224647e-17, 4.825269e-01
-1601, 5.000000e-02, -1.224647e-17, 4.939230e-01
-1602, -4.164202e-02, 4.319655e-02, 3.607786e-01
-1603, -4.552380e-02, 3.908432e-02, 3.489870e-01
-1604, -5.050521e-02, 3.239172e-02, 3.635282e-01
-1605, -5.897960e-02, -1.101846e-02, 2.734159e-01
-1606, -5.504227e-02, -2.388196e-02, 2.798545e-01
-1607, -5.896706e-02, -1.108540e-02, 2.867984e-01
-1608, -5.644181e-02, 2.035491e-02, 3.428490e-01
-1609, -5.235877e-02, 2.930118e-02, 3.374086e-01
-1610, -5.571252e-02, 2.227364e-02, 3.285212e-01
-1611, -5.899465e-02, -1.093761e-02, 3.014834e-01
-1612, -5.994868e-02, 2.481113e-03, 2.950449e-01
-1613, -5.998361e-02, 1.402187e-03, 2.430834e-01
-1614, -5.879960e-02, 1.194180e-02, 2.563007e-01
-1615, -5.803774e-02, 1.521909e-02, 2.444887e-01
-1616, -2.488485e-02, 5.459619e-02, 3.916180e-01
-1617, -3.531085e-02, 4.850922e-02, 3.896118e-01
-1618, -3.292176e-02, 5.016132e-02, 4.030279e-01
-1619, -5.851890e-02, -1.324910e-02, 3.148443e-01
-1620, -5.403097e-02, -2.608936e-02, 3.065978e-01
-1621, -5.681978e-02, 1.927466e-02, 2.143116e-01
-1622, -5.963227e-02, 6.632704e-03, 2.174118e-01
-1623, -5.739540e-02, 1.748624e-02, 2.281712e-01
-1624, -5.143874e-02, 3.088779e-02, 2.107287e-01
-1625, -5.624182e-02, 2.090114e-02, 1.999693e-01
-1626, -5.999972e-02, 1.843315e-04, 2.676277e-01
-1627, -5.833470e-02, 1.403789e-02, 2.690329e-01
-1628, -5.680066e-02, -1.933093e-02, 3.276585e-01
-1629, -5.988653e-02, -3.688331e-03, 3.225440e-01
-1630, -5.854762e-02, -1.312158e-02, 2.606837e-01
-1631, -5.998173e-02, 1.480519e-03, 3.346599e-01
-1632, -5.949326e-02, 7.781512e-03, 3.218457e-01
-1633, -5.341985e-02, 2.731885e-02, 2.413885e-01
-1634, -5.932612e-02, -8.967217e-03, 2.352897e-01
-1635, -5.873017e-02, -1.227871e-02, 2.471018e-01
-1636, -5.540602e-02, -2.302548e-02, 2.528900e-01
-1637, -5.538543e-02, 2.307498e-02, 1.853236e-01
-1638, -5.901954e-02, 1.080250e-02, 1.889065e-01
-1639, -5.742308e-02, 1.739511e-02, 3.164053e-01
-1640, -5.785320e-02, 1.590620e-02, 3.013344e-01
-1641, -5.789288e-02, 1.576118e-02, 2.866494e-01
-1642, -5.431930e-02, 2.548359e-02, 1.720211e-01
-1643, -4.906022e-02, 3.454120e-02, 1.830839e-01
-1644, -5.751971e-02, 1.707287e-02, 3.535495e-01
-1645, -5.924636e-02, 9.479941e-03, 3.446620e-01
-1646, -5.996752e-02, -1.973962e-03, 3.453603e-01
-1647, -5.368029e-02, 2.680348e-02, 2.753224e-01
-1648, -5.736537e-02, 1.758449e-02, 1.606249e-01
-1649, -5.218416e-02, 2.961103e-02, 1.583852e-01
-1650, -5.986392e-02, -4.038673e-03, 3.559452e-01
-1651, -5.878787e-02, -1.199943e-02, 3.459431e-01
-1652, -5.149329e-02, -3.079678e-02, 3.340509e-01
-1653, -5.576739e-02, -2.213591e-02, 3.417506e-01
-1654, -5.497170e-02, -2.404396e-02, 3.523355e-01
-1655, -5.958588e-02, -7.037254e-03, 2.215691e-01
-1656, -5.977700e-02, -5.168231e-03, 2.077095e-01
-1657, -5.999334e-02, -8.939028e-04, 1.781766e-01
-1658, -5.991305e-02, -3.228971e-03, 1.928223e-01
-1659, -5.762718e-02, -1.670653e-02, 1.969795e-01
-1660, -5.211133e-02, 2.973902e-02, 3.080098e-01
-1661, -4.677900e-02, -3.757293e-02, 3.124571e-01
-1662, -4.822036e-02, -3.570429e-02, 2.990961e-01
-1663, -4.891318e-02, -3.474912e-02, 2.723567e-01
-1664, -4.887370e-02, -3.480461e-02, 2.857392e-01
-1665, -3.979374e-02, -4.490499e-02, 2.915984e-01
-1666, -5.996483e-02, 2.054007e-03, 1.612862e-01
-1667, -5.879646e-02, -1.195725e-02, 1.652020e-01
-1668, -5.962602e-02, 6.688636e-03, 1.476503e-01
-1669, -4.027129e-02, 4.447722e-02, 1.792741e-01
-1670, -4.218458e-02, 4.266687e-02, 1.925766e-01
-1671, -5.642319e-02, -2.040645e-02, 2.255874e-01
-1672, -5.217657e-02, -2.962441e-02, 3.596742e-01
-1673, -5.656780e-02, -2.000211e-02, 3.638667e-01
-1674, -5.210983e-02, -2.974165e-02, 2.030316e-01
-1675, -5.304600e-02, -2.803787e-02, 1.881444e-01
-1676, -5.497413e-02, -2.403841e-02, 1.560345e-01
-1677, -5.372702e-02, -2.670969e-02, 1.729248e-01
-1678, -4.914652e-02, -3.441830e-02, 3.728283e-01
-1679, -4.652647e-02, -3.788519e-02, 3.612971e-01
-1680, -4.701403e-02, -3.727842e-02, 1.482540e-01
-1681, -5.503476e-02, -2.389928e-02, 1.405311e-01
-1682, -3.797482e-02, -4.645334e-02, 3.651120e-01
-1683, -4.219106e-02, -4.266046e-02, 3.519579e-01
-1684, -5.395788e-02, -2.624017e-02, 3.834070e-01
-1685, -4.884554e-02, -3.484413e-02, 3.850299e-01
-1686, -4.111375e-02, -4.369965e-02, 2.645932e-01
-1687, -4.930140e-02, -3.419608e-02, 2.587084e-01
-1688, -4.978782e-02, -3.348392e-02, 2.451265e-01
-1689, -4.416024e-02, 4.061863e-02, 3.346591e-01
-1690, -3.289986e-02, 5.017568e-02, 2.021297e-01
-1691, -4.312110e-02, 4.172014e-02, 2.059394e-01
-1692, -4.430337e-02, 4.046247e-02, 2.202818e-01
-1693, -4.349552e-02, -4.132965e-02, 3.398869e-01
-1694, -4.549997e-02, -3.911205e-02, 3.257948e-01
-1695, -3.741126e-02, -4.690839e-02, 3.182931e-01
-1696, -4.487676e-02, 3.982557e-02, 3.019841e-01
-1697, -4.383319e-02, 4.097135e-02, 3.170550e-01
-1698, -4.712689e-02, -3.713564e-02, 3.959578e-01
-1699, -4.068332e-02, -4.410065e-02, 3.853791e-01
-1700, -3.913607e-02, 4.547931e-02, 1.677793e-01
-1701, -3.048377e-02, 5.167920e-02, 1.772719e-01
-1702, -4.360038e-02, 4.121901e-02, 1.569959e-01
-1703, -4.896790e-02, 3.467196e-02, 1.455997e-01
-1704, -5.908933e-02, -1.041396e-02, 3.666456e-01
-1705, -5.999892e-02, -3.603883e-04, 3.660628e-01
-1706, -5.597873e-02, 2.159586e-02, 3.640059e-01
-1707, -5.902266e-02, 1.078545e-02, 3.658189e-01
-1708, -5.983733e-02, 4.415169e-03, 3.765192e-01
-1709, -4.597482e-02, -3.855277e-02, 1.789768e-01
-1710, -5.035523e-02, -3.262440e-02, 2.311696e-01
-1711, -5.138742e-02, -3.097309e-02, 2.174489e-01
-1712, -4.404463e-02, -4.074396e-02, 2.086138e-01
-1713, -3.431417e-02, -4.921928e-02, 3.437018e-01
-1714, -4.233923e-02, -4.251340e-02, 2.369880e-01
-1715, -3.824589e-02, 4.623042e-02, 3.767608e-01
-1716, -3.146337e-02, 5.108871e-02, 3.622196e-01
-1717, -5.369697e-02, 2.677005e-02, 3.757976e-01
-1718, -5.768783e-02, -1.649590e-02, 3.739843e-01
-1719, -3.485712e-02, 4.883627e-02, 3.286333e-01
-1720, -4.477920e-02, 3.993523e-02, 2.352617e-01
-1721, -4.631275e-02, 3.814616e-02, 2.515791e-01
-1722, -4.500372e-02, 3.968205e-02, 2.853324e-01
-1723, -4.616040e-02, 3.833037e-02, 2.677159e-01
-1724, -3.497200e-02, 4.875407e-02, 2.615891e-01
-1725, -4.485032e-02, 3.985535e-02, 3.881707e-01
-1726, -5.999819e-02, 4.665824e-04, 1.345326e-01
-1727, -5.781058e-02, 1.606041e-02, 1.338713e-01
-1728, -4.452207e-02, 4.022170e-02, 1.325225e-01
-1729, -5.284095e-02, 2.842242e-02, 1.339118e-01
-1730, -5.550452e-02, 2.278701e-02, 1.207941e-01
-1731, -3.440107e-02, 4.915858e-02, 1.549937e-01
-1732, -3.458807e-02, 4.902719e-02, 2.304724e-01
-1733, -1.541230e-03, 5.998020e-02, 3.244677e-01
-1734, 1.166187e-03, 5.998867e-02, 3.357887e-01
-1735, 1.253537e-02, 5.867593e-02, 3.305906e-01
-1736, -2.202678e-02, 5.581058e-02, 2.698420e-01
-1737, -2.224896e-02, 5.572238e-02, 2.537052e-01
-1738, -3.462116e-02, 4.900383e-02, 2.943775e-01
-1739, -2.039942e-02, 5.642573e-02, 1.338366e-01
-1740, -8.267956e-03, 5.942761e-02, 1.370623e-01
-1741, -1.622513e-02, 5.776457e-02, 1.225084e-01
-1742, -2.238445e-02, 5.566809e-02, 2.093338e-01
-1743, -2.114348e-02, 5.615116e-02, 1.959710e-01
-1744, 1.258208e-02, 5.866593e-02, 4.285674e-01
-1745, 1.145679e-02, 5.889603e-02, 4.186757e-01
-1746, 1.717246e-03, 5.997542e-02, 4.215227e-01
-1747, -2.632796e-02, -5.391511e-02, 3.671898e-01
-1748, -3.196309e-02, -5.077756e-02, 3.765290e-01
-1749, 5.974720e-02, 5.501984e-03, 4.939230e-01
-1750, 5.873220e-02, 1.226901e-02, 4.952757e-01
-1751, 5.746291e-02, 1.726308e-02, 4.952757e-01
-1752, 5.565508e-02, 2.241679e-02, 4.950700e-01
-1753, 5.360943e-02, 2.694493e-02, 4.950700e-01
-1754, 5.696784e-02, 1.883255e-02, 4.903457e-01
-1755, 5.104371e-02, 3.153632e-02, 4.948468e-01
-1756, 4.825931e-02, 3.565163e-02, 4.948468e-01
-1757, 5.271184e-02, 2.866116e-02, 4.899168e-01
-1758, 4.498332e-02, 3.970517e-02, 4.947966e-01
-1759, 4.154379e-02, 4.329103e-02, 4.947966e-01
-1760, 4.693231e-02, 3.738125e-02, 4.896433e-01
-1761, 3.767758e-02, 4.669476e-02, 4.950761e-01
-1762, 3.345571e-02, 4.980678e-02, 4.950761e-01
-1763, 3.980741e-02, 4.489287e-02, 4.898727e-01
-1764, 2.888013e-02, 5.259219e-02, 4.950531e-01
-1765, 2.423643e-02, 5.488712e-02, 4.950531e-01
-1766, 3.137374e-02, 5.114380e-02, 4.901293e-01
-1767, 1.959376e-02, 5.671053e-02, 4.947423e-01
-1768, 1.483423e-02, 5.813730e-02, 4.947423e-01
-1769, 2.213151e-02, 5.576913e-02, 4.897955e-01
-1770, 9.679704e-03, 5.921405e-02, 4.948201e-01
-1771, 4.226466e-03, 5.985096e-02, 4.948201e-01
-1772, 1.232171e-02, 5.872117e-02, 4.895624e-01
-1773, -1.001721e-03, 5.999164e-02, 4.949016e-01
-1774, -5.962108e-03, 5.970304e-02, 4.949016e-01
-1775, 1.910465e-03, 5.996958e-02, 4.897217e-01
-1776, -1.107602e-02, 5.896882e-02, 4.948797e-01
-1777, -1.591723e-02, 5.785017e-02, 4.948797e-01
-1778, -8.460603e-03, 5.940049e-02, 4.897813e-01
-1779, -2.090849e-02, 5.623909e-02, 4.946093e-01
-1780, -2.571230e-02, 5.421142e-02, 4.946093e-01
-1781, -1.859216e-02, 5.704675e-02, 4.894890e-01
-1782, -3.032659e-02, 5.177159e-02, 4.945466e-01
-1783, -3.467888e-02, 4.896300e-02, 4.945466e-01
-1784, -2.821206e-02, 5.295356e-02, 4.891558e-01
-1785, -3.864166e-02, 4.590013e-02, 4.946200e-01
-1786, -4.230702e-02, 4.254546e-02, 4.946200e-01
-1787, -3.678882e-02, 4.739813e-02, 4.891665e-01
-1788, -4.575926e-02, 3.880838e-02, 4.950178e-01
-1789, -4.902747e-02, 3.458768e-02, 4.950178e-01
-1790, -4.420924e-02, 4.056529e-02, 4.896378e-01
-1791, -5.179589e-02, 3.028508e-02, 4.951036e-01
-1792, -5.416382e-02, 2.581241e-02, 4.951036e-01
-1793, -5.043867e-02, 3.249524e-02, 4.901214e-01
-1794, -5.614547e-02, 2.115860e-02, 4.948446e-01
-1795, -5.770365e-02, 1.644046e-02, 4.948446e-01
-1796, -5.520039e-02, 2.351418e-02, 4.899482e-01
-1797, -5.887528e-02, 1.156293e-02, 4.949905e-01
-1798, -5.964175e-02, 6.546843e-03, 4.949905e-01
-1799, -5.835445e-02, 1.395556e-02, 4.898351e-01
-1800, -5.998542e-02, 1.322560e-03, 4.949347e-01
-1801, -5.985518e-02, -4.166201e-03, 4.949347e-01
-1802, -5.987783e-02, 3.826982e-03, 4.899252e-01
-1803, -5.929878e-02, -9.146273e-03, 4.946334e-01
-1804, -5.833867e-02, -1.402141e-02, 4.946334e-01
-1805, -5.965684e-02, -6.407927e-03, 4.895680e-01
-1806, -5.694223e-02, -1.890986e-02, 4.946598e-01
-1807, -5.518234e-02, -2.355652e-02, 4.946598e-01
-1808, -5.774057e-02, -1.631033e-02, 4.892932e-01
-1809, -5.298197e-02, -2.815867e-02, 4.947931e-01
-1810, -5.045378e-02, -3.247177e-02, 4.947931e-01
-1811, -5.415390e-02, -2.583322e-02, 4.894529e-01
-1812, -4.747163e-02, -3.669393e-02, 4.948295e-01
-1813, -4.402318e-02, -4.076714e-02, 4.948295e-01
-1814, -4.896035e-02, -3.468262e-02, 4.896226e-01
-1815, -4.036734e-02, -4.439007e-02, 4.947276e-01
-1816, -3.655600e-02, -4.757792e-02, 4.947276e-01
-1817, -4.230242e-02, -4.255003e-02, 4.895571e-01
-1818, -3.242578e-02, -5.048335e-02, 4.946928e-01
-1819, -2.801721e-02, -5.305691e-02, 4.946928e-01
-1820, -3.449409e-02, -4.909336e-02, 4.894204e-01
-1821, -2.339755e-02, -5.524993e-02, 4.946870e-01
-1822, -1.870010e-02, -5.701146e-02, 4.946870e-01
-1823, -2.572131e-02, -5.420714e-02, 4.893798e-01
-1824, -1.380698e-02, -5.838979e-02, 4.946570e-01
-1825, -8.928353e-03, -5.933199e-02, 4.946570e-01
-1826, -1.617927e-02, -5.777743e-02, 4.893439e-01
-1827, -4.018144e-03, -5.986530e-02, 4.947816e-01
-1828, 9.490042e-04, -5.999249e-02, 4.947816e-01
-1829, -6.344614e-03, -5.966361e-02, 4.894385e-01
-1830, 6.058554e-03, -5.969333e-02, 4.947461e-01
-1831, 1.097692e-02, -5.898735e-02, 4.947461e-01
-1832, 3.701487e-03, -5.988572e-02, 4.895277e-01
-1833, 1.581052e-02, -5.787942e-02, 4.946064e-01
-1834, 2.054536e-02, -5.637276e-02, 4.946064e-01
-1835, 1.366313e-02, -5.842362e-02, 4.893525e-01
-1836, 2.499949e-02, -5.454380e-02, 4.950603e-01
-1837, 2.947283e-02, -5.226234e-02, 4.950603e-01
-1838, 2.295988e-02, -5.543324e-02, 4.896667e-01
-1839, 3.377276e-02, -4.959235e-02, 4.953736e-01
-1840, 3.787951e-02, -4.653109e-02, 4.953736e-01
-1841, 3.173548e-02, -5.092013e-02, 4.904339e-01
-1842, 4.164879e-02, -4.319003e-02, 4.952408e-01
-1843, 4.507960e-02, -3.959583e-02, 4.952408e-01
-1844, 3.981902e-02, -4.488258e-02, 4.906144e-01
-1845, 4.807643e-02, -3.589787e-02, 4.955572e-01
-1846, 5.102776e-02, -3.156213e-02, 4.955572e-01
-1847, 4.658697e-02, -3.781077e-02, 4.907980e-01
-1848, 5.347523e-02, -2.721028e-02, 4.955958e-01
-1849, 5.554330e-02, -2.269233e-02, 4.955958e-01
-1850, 5.209315e-02, -2.977086e-02, 4.911530e-01
-1851, 5.709876e-02, -1.843182e-02, 4.956744e-01
-1852, 5.848342e-02, -1.340482e-02, 4.956744e-01
-1853, 5.614651e-02, -2.115583e-02, 4.912703e-01
-1854, 5.934921e-02, -8.813109e-03, 4.955701e-01
-1855, 5.987535e-02, -3.865543e-03, 4.955701e-01
-1856, 5.987535e-02, -3.865543e-03, 4.894931e-01
-1857, 5.872112e-02, -1.232195e-02, 4.912445e-01
-1858, 5.979421e-02, -4.965166e-03, 5.890884e-03
-1859, 5.987725e-02, -3.835941e-03, 2.002263e-02
-1860, 5.987725e-02, -3.835941e-03, 1.482160e-02
-1861, 5.977439e-02, -5.198352e-03, 4.235437e-02
-1862, 5.977439e-02, -5.198352e-03, 3.601056e-02
-1863, 5.975702e-02, -5.394344e-03, 6.407228e-02
-1864, 5.975702e-02, -5.394344e-03, 5.856157e-02
-1865, 5.975241e-02, -5.445086e-03, 8.669683e-02
-1866, 5.975241e-02, -5.445086e-03, 8.082837e-02
-1867, 5.982495e-02, -4.579847e-03, 1.080195e-01
-1868, 5.982495e-02, -4.579847e-03, 1.026520e-01
-1869, 5.980722e-02, -4.805873e-03, 1.304108e-01
-1870, 5.980722e-02, -4.805873e-03, 1.254276e-01
-1871, 5.965409e-02, -6.433447e-03, 1.525936e-01
-1872, 5.965409e-02, -6.433447e-03, 1.470381e-01
-1873, 5.971941e-02, -5.795917e-03, 1.754448e-01
-1874, 5.971941e-02, -5.795917e-03, 1.702214e-01
-1875, 5.976826e-02, -5.268255e-03, 1.973734e-01
-1876, 5.976826e-02, -5.268255e-03, 1.910520e-01
-1877, 5.965985e-02, -6.379826e-03, 2.181757e-01
-1878, 5.965985e-02, -6.379826e-03, 2.126650e-01
-1879, 5.965364e-02, -6.437653e-03, 2.414914e-01
-1880, 5.965364e-02, -6.437653e-03, 2.356678e-01
-1881, 5.982395e-02, -4.592994e-03, 2.632482e-01
-1882, 5.982395e-02, -4.592994e-03, 2.578807e-01
-1883, 5.982046e-02, -4.638194e-03, 2.856448e-01
-1884, 5.982046e-02, -4.638194e-03, 2.806616e-01
-1885, 5.966539e-02, -6.327832e-03, 3.076748e-01
-1886, 5.966539e-02, -6.327832e-03, 3.020744e-01
-1887, 5.971371e-02, -5.854350e-03, 3.303521e-01
-1888, 5.971371e-02, -5.854350e-03, 3.251063e-01
-1889, 5.963636e-02, -6.595776e-03, 3.528306e-01
-1890, 5.963636e-02, -6.595776e-03, 3.465317e-01
-1891, 5.971721e-02, -5.818516e-03, 3.741640e-01
-1892, 5.971721e-02, -5.818516e-03, 3.686533e-01
-1893, 5.967787e-02, -6.209026e-03, 3.973831e-01
-1894, 5.967787e-02, -6.209026e-03, 3.916043e-01
-1895, 5.971235e-02, -5.868136e-03, 4.194205e-01
-1896, 5.971235e-02, -5.868136e-03, 4.133458e-01
-1897, 5.970336e-02, -5.958961e-03, 4.405074e-01
-1898, 5.970336e-02, -5.958961e-03, 4.349966e-01
-1899, 5.982596e-02, -4.566610e-03, 4.633155e-01
-1900, 5.982596e-02, -4.566610e-03, 4.579154e-01
-1901, 5.992569e-02, -2.985177e-03, 4.848627e-01
-1902, 5.992569e-02, -2.985177e-03, 4.795436e-01
-1903, 5.960888e-02, -6.839731e-03, 4.865098e-01
-1904, 5.974874e-02, 5.485208e-03, 5.890884e-03
-1905, 5.754038e-02, 1.700309e-02, 4.679643e-03
-1906, 5.878721e-02, 1.200268e-02, 4.679643e-03
-1907, 4.817307e-02, 3.576808e-02, 5.595919e-03
-1908, 5.096775e-02, 3.165895e-02, 5.595919e-03
-1909, 3.275217e-02, 5.027221e-02, 5.994213e-03
-1910, 3.701789e-02, 4.721945e-02, 5.994213e-03
-1911, 1.450785e-02, 5.821961e-02, 4.170435e-03
-1912, 1.927592e-02, 5.681935e-02, 4.170435e-03
-1913, -5.721666e-03, 5.972656e-02, 5.913325e-03
-1914, -7.595028e-04, 5.999519e-02, 5.913325e-03
-1915, -2.574555e-02, 5.419563e-02, 6.220414e-03
-1916, -2.094237e-02, 5.622648e-02, 6.220414e-03
-1917, -4.211126e-02, 4.273923e-02, 4.298954e-03
-1918, -3.843004e-02, 4.607746e-02, 4.298954e-03
-1919, -5.424560e-02, 2.564009e-02, 7.012171e-03
-1920, -5.189157e-02, 3.012083e-02, 7.012171e-03
-1921, -5.966549e-02, 6.326849e-03, 6.581677e-03
-1922, -5.891740e-02, 1.134637e-02, 6.581677e-03
-1923, -5.827547e-02, -1.428178e-02, 4.565747e-03
-1924, -5.925745e-02, -9.410343e-03, 4.565747e-03
-1925, -5.100846e-02, -3.159331e-02, 6.346146e-03
-1926, -5.346188e-02, -2.723650e-02, 6.346146e-03
-1927, -3.693354e-02, -4.728545e-02, 6.206733e-03
-1928, -4.071987e-02, -4.406691e-02, 6.206733e-03
-1929, -1.861075e-02, -5.704069e-02, 6.038656e-03
-1930, -2.331176e-02, -5.528618e-02, 6.038656e-03
-1931, 6.504326e-04, -5.999647e-02, 6.142506e-03
-1932, -4.316673e-03, -5.984452e-02, 6.142506e-03
-1933, 2.075298e-02, -5.629666e-02, 6.491944e-03
-1934, 1.602309e-02, -5.782093e-02, 6.491944e-03
-1935, 3.849573e-02, -4.602259e-02, 5.316632e-03
-1936, 3.442957e-02, -4.913863e-02, 5.316632e-03
-1937, 5.113208e-02, -3.139283e-02, 5.199753e-03
-1938, 4.819476e-02, -3.573885e-02, 5.199753e-03
-1939, 5.886125e-02, -1.163415e-02, 4.568661e-03
-1940, 5.762871e-02, -1.670127e-02, 4.568661e-03
-1941, 5.988277e-02, 3.748906e-03, 1.471571e-02
-1942, 5.988277e-02, 3.748906e-03, 1.991674e-02
-1943, 5.984258e-02, 4.343411e-03, 2.482379e-02
-1944, 5.984258e-02, 4.343411e-03, 3.019127e-02
-1945, 5.945427e-02, 8.073995e-03, 2.255670e-02
-1946, 5.980401e-02, 4.845673e-03, 3.565147e-02
-1947, 5.980401e-02, 4.845673e-03, 4.199527e-02
-1948, 5.929633e-02, 9.162183e-03, 3.292395e-02
-1949, 5.979218e-02, 4.989512e-03, 4.766059e-02
-1950, 5.979218e-02, 4.989512e-03, 5.264382e-02
-1951, 5.919391e-02, 9.802102e-03, 4.404947e-02
-1952, 5.976998e-02, 5.248753e-03, 5.820381e-02
-1953, 5.976998e-02, 5.248753e-03, 6.371453e-02
-1954, 5.912648e-02, 1.020096e-02, 5.527478e-02
-1955, 5.976490e-02, 5.306287e-03, 6.931362e-02
-1956, 5.976490e-02, 5.306287e-03, 7.484676e-02
-1957, 5.907159e-02, 1.051413e-02, 6.643386e-02
-1958, 5.976771e-02, 5.274589e-03, 8.050920e-02
-1959, 5.976771e-02, 5.274589e-03, 8.637766e-02
-1960, 5.906704e-02, 1.053967e-02, 7.769540e-02
-1961, 5.978853e-02, 5.033102e-03, 9.181628e-02
-1962, 5.978853e-02, 5.033102e-03, 9.702851e-02
-1963, 5.911459e-02, 1.026961e-02, 8.879645e-02
-1964, 5.979025e-02, 5.012582e-03, 1.025689e-01
-1965, 5.979025e-02, 5.012582e-03, 1.079364e-01
-1966, 5.915904e-02, 1.001042e-02, 9.977543e-02
-1967, 5.977485e-02, 5.192956e-03, 1.136369e-01
-1968, 5.977485e-02, 5.192956e-03, 1.199695e-01
-1969, 5.913206e-02, 1.016857e-02, 1.110163e-01
-1970, 5.976360e-02, 5.320937e-03, 1.255505e-01
-1971, 5.976360e-02, 5.320937e-03, 1.305337e-01
-1972, 5.907882e-02, 1.047347e-02, 1.222979e-01
-1973, 5.975082e-02, 5.462514e-03, 1.359404e-01
-1974, 5.975082e-02, 5.462514e-03, 1.414511e-01
-1975, 5.903098e-02, 1.073983e-02, 1.332856e-01
-1976, 5.975633e-02, 5.401978e-03, 1.469986e-01
-1977, 5.975633e-02, 5.401978e-03, 1.525541e-01
-1978, 5.901636e-02, 1.081987e-02, 1.442397e-01
-1979, 5.976474e-02, 5.308044e-03, 1.581865e-01
-1980, 5.976474e-02, 5.308044e-03, 1.640325e-01
-1981, 5.904413e-02, 1.066728e-02, 1.554195e-01
-1982, 5.978017e-02, 5.131348e-03, 1.694890e-01
-1983, 5.978017e-02, 5.131348e-03, 1.747125e-01
-1984, 5.909182e-02, 1.039983e-02, 1.665084e-01
-1985, 5.977594e-02, 5.180487e-03, 1.802820e-01
-1986, 5.977594e-02, 5.180487e-03, 1.856494e-01
-1987, 5.911388e-02, 1.027369e-02, 1.775343e-01
-1988, 5.976651e-02, 5.288100e-03, 1.912496e-01
-1989, 5.976651e-02, 5.288100e-03, 1.975710e-01
-1990, 5.908674e-02, 1.042868e-02, 1.887040e-01
-1991, 5.977576e-02, 5.182549e-03, 2.031828e-01
-1992, 5.977576e-02, 5.182549e-03, 2.081660e-01
-1993, 5.908638e-02, 1.043072e-02, 1.999159e-01
-1994, 5.977159e-02, 5.230412e-03, 2.136610e-01
-1995, 5.977159e-02, 5.230412e-03, 2.191717e-01
-1996, 5.909642e-02, 1.037368e-02, 2.110227e-01
-1997, 5.976594e-02, 5.294536e-03, 2.247146e-01
-1998, 5.976594e-02, 5.294536e-03, 2.302926e-01
-1999, 5.907688e-02, 1.048439e-02, 2.220606e-01
-2000, 5.976221e-02, 5.336474e-03, 2.358985e-01
-2001, 5.976221e-02, 5.336474e-03, 2.417221e-01
-2002, 5.905818e-02, 1.058921e-02, 2.332094e-01
-2003, 5.977991e-02, 5.134388e-03, 2.470895e-01
-2004, 5.977991e-02, 5.134388e-03, 2.523242e-01
-2005, 5.908634e-02, 1.043094e-02, 2.441827e-01
-2006, 5.978447e-02, 5.081046e-03, 2.578736e-01
-2007, 5.978447e-02, 5.081046e-03, 2.632411e-01
-2008, 5.913037e-02, 1.017835e-02, 2.550995e-01
-2009, 5.977824e-02, 5.153814e-03, 2.688843e-01
-2010, 5.977824e-02, 5.153814e-03, 2.751945e-01
-2011, 5.912706e-02, 1.019757e-02, 2.662922e-01
-2012, 5.978188e-02, 5.111479e-03, 2.807619e-01
-2013, 5.978188e-02, 5.111479e-03, 2.857451e-01
-2014, 5.912186e-02, 1.022766e-02, 2.775028e-01
-2015, 5.977851e-02, 5.150694e-03, 2.912022e-01
-2016, 5.977851e-02, 5.150694e-03, 2.967129e-01
-2017, 5.912240e-02, 1.022458e-02, 2.885273e-01
-2018, 5.977599e-02, 5.179826e-03, 3.022636e-01
-2019, 5.977599e-02, 5.179826e-03, 3.078640e-01
-2020, 5.911067e-02, 1.029217e-02, 2.995351e-01
-2021, 5.977292e-02, 5.215145e-03, 3.134892e-01
-2022, 5.977292e-02, 5.215145e-03, 3.192904e-01
-2023, 5.909954e-02, 1.035590e-02, 3.107110e-01
-2024, 5.977828e-02, 5.153339e-03, 3.247386e-01
-2025, 5.977828e-02, 5.153339e-03, 3.299845e-01
-2026, 5.910412e-02, 1.032971e-02, 3.217843e-01
-2027, 5.976430e-02, 5.313005e-03, 3.355683e-01
-2028, 5.976430e-02, 5.313005e-03, 3.409358e-01
-2029, 5.908713e-02, 1.042647e-02, 3.328164e-01
-2030, 5.975086e-02, 5.462131e-03, 3.465805e-01
-2031, 5.975086e-02, 5.462131e-03, 3.528794e-01
-2032, 5.903247e-02, 1.073162e-02, 3.440449e-01
-2033, 5.976903e-02, 5.259542e-03, 3.583279e-01
-2034, 5.976903e-02, 5.259542e-03, 3.633111e-01
-2035, 5.904204e-02, 1.067881e-02, 3.551380e-01
-2036, 5.977088e-02, 5.238471e-03, 3.688730e-01
-2037, 5.977088e-02, 5.238471e-03, 3.743837e-01
-2038, 5.908160e-02, 1.045776e-02, 3.661483e-01
-2039, 5.977825e-02, 5.153748e-03, 3.799775e-01
-2040, 5.977825e-02, 5.153748e-03, 3.856003e-01
-2041, 5.910001e-02, 1.035318e-02, 3.773040e-01
-2042, 5.977823e-02, 5.153907e-03, 3.912619e-01
-2043, 5.977823e-02, 5.153907e-03, 3.970407e-01
-2044, 5.911460e-02, 1.026956e-02, 3.885594e-01
-2045, 5.979012e-02, 5.014171e-03, 4.025281e-01
-2046, 5.979012e-02, 5.014171e-03, 4.077852e-01
-2047, 5.913842e-02, 1.013152e-02, 3.997084e-01
-2048, 5.977398e-02, 5.202979e-03, 4.135098e-01
-2049, 5.977398e-02, 5.202979e-03, 4.195845e-01
-2050, 5.913008e-02, 1.018006e-02, 4.109205e-01
-2051, 5.977630e-02, 5.176312e-03, 4.251046e-01
-2052, 5.977630e-02, 5.176312e-03, 4.300879e-01
-2053, 5.910225e-02, 1.034039e-02, 4.221653e-01
-2054, 5.976515e-02, 5.303447e-03, 4.357252e-01
-2055, 5.976515e-02, 5.303447e-03, 4.412359e-01
-2056, 5.908479e-02, 1.043973e-02, 4.333227e-01
-2057, 5.978202e-02, 5.109810e-03, 4.469525e-01
-2058, 5.978202e-02, 5.109810e-03, 4.529540e-01
-2059, 5.909636e-02, 1.037399e-02, 4.446766e-01
-2060, 5.980414e-02, 4.844045e-03, 4.586056e-01
-2061, 5.980414e-02, 4.844045e-03, 4.640057e-01
-2062, 5.917434e-02, 9.919576e-03, 4.560447e-01
-2063, 5.983211e-02, 4.485431e-03, 4.693605e-01
-2064, 5.983211e-02, 4.485431e-03, 4.748069e-01
-2065, 5.927467e-02, 9.301279e-03, 4.670511e-01
-2066, 5.987932e-02, 3.803512e-03, 4.796110e-01
-2067, 5.987932e-02, 3.803512e-03, 4.849301e-01
-2068, 5.942743e-02, 8.269279e-03, 4.772100e-01
-2069, 5.962212e-02, -6.723314e-03, 1.045954e-02
-2070, 5.960981e-02, 6.831585e-03, 4.891986e-01
-2071, 5.963832e-02, 6.578085e-03, 1.057053e-02
-2072, 5.981156e-02, -4.751590e-03, 3.045671e-02
-2073, 5.981156e-02, -4.751590e-03, 2.508923e-02
-2074, 5.976324e-02, -5.324969e-03, 5.289752e-02
-2075, 5.976324e-02, -5.324969e-03, 4.791428e-02
-2076, 5.974887e-02, -5.483865e-03, 7.507099e-02
-2077, 5.974887e-02, -5.483865e-03, 6.953786e-02
-2078, 5.974686e-02, -5.505750e-03, 9.745105e-02
-2079, 5.974686e-02, -5.505750e-03, 9.223881e-02
-2080, 5.963772e-02, -6.583500e-03, 1.198092e-01
-2081, 5.963772e-02, -6.583500e-03, 1.134766e-01
-2082, 5.970084e-02, -5.984076e-03, 1.411924e-01
-2083, 5.970084e-02, -5.984076e-03, 1.356817e-01
-2084, 5.965988e-02, -6.379592e-03, 1.644256e-01
-2085, 5.965988e-02, -6.379592e-03, 1.585796e-01
-2086, 5.985812e-02, -4.123800e-03, 1.858137e-01
-2087, 5.985812e-02, -4.123800e-03, 1.804462e-01
-2088, 5.980749e-02, -4.802493e-03, 2.076550e-01
-2089, 5.980749e-02, -4.802493e-03, 2.026717e-01
-2090, 5.963453e-02, -6.612283e-03, 2.296585e-01
-2091, 5.963453e-02, -6.612283e-03, 2.240805e-01
-2092, 5.971888e-02, -5.801353e-03, 2.525591e-01
-2093, 5.971888e-02, -5.801353e-03, 2.473244e-01
-2094, 5.965625e-02, -6.413427e-03, 2.750785e-01
-2095, 5.965625e-02, -6.413427e-03, 2.687683e-01
-2096, 5.971961e-02, -5.793850e-03, 2.963700e-01
-2097, 5.971961e-02, -5.793850e-03, 2.908593e-01
-2098, 5.966468e-02, -6.334551e-03, 3.193521e-01
-2099, 5.966468e-02, -6.334551e-03, 3.135509e-01
-2100, 5.981668e-02, -4.686637e-03, 3.409868e-01
-2101, 5.981668e-02, -4.686637e-03, 3.356193e-01
-2102, 5.981342e-02, -4.728134e-03, 3.633667e-01
-2103, 5.981342e-02, -4.728134e-03, 3.583835e-01
-2104, 5.966882e-02, -6.295424e-03, 3.856199e-01
-2105, 5.966882e-02, -6.295424e-03, 3.799971e-01
-2106, 5.979892e-02, -4.908060e-03, 4.079609e-01
-2107, 5.979892e-02, -4.908060e-03, 4.027039e-01
-2108, 5.980406e-02, -4.845017e-03, 4.297571e-01
-2109, 5.980406e-02, -4.845017e-03, 4.247739e-01
-2110, 5.973770e-02, -5.604259e-03, 4.523661e-01
-2111, 5.973770e-02, -5.604259e-03, 4.463646e-01
-2112, 5.967550e-02, -6.231737e-03, 4.742332e-01
-2113, 5.967550e-02, -6.231737e-03, 4.687867e-01
-2114, 5.907716e-02, -1.048278e-02, 4.466226e-02
-2115, 5.571346e-02, 2.227129e-02, 5.038179e-03
-2116, 5.709080e-02, 1.845646e-02, 9.717822e-03
-2117, 5.367936e-02, 2.680535e-02, 5.038179e-03
-2118, 5.270266e-02, 2.867804e-02, 1.063410e-02
-2119, 4.118611e-02, 4.363146e-02, 5.896428e-03
-2120, 4.465547e-02, 4.007355e-02, 5.896428e-03
-2121, 2.353410e-02, 5.519190e-02, 5.525011e-03
-2122, 2.820729e-02, 5.295610e-02, 5.525011e-03
-2123, 4.493574e-03, 5.983150e-02, 5.429984e-03
-2124, 9.944559e-03, 5.917014e-02, 5.429984e-03
-2125, -1.592930e-02, 5.784685e-02, 6.197930e-03
-2126, -1.108767e-02, 5.896663e-02, 6.197930e-03
-2127, -3.465304e-02, 4.898129e-02, 5.263360e-03
-2128, -3.029871e-02, 5.178792e-02, 5.263360e-03
-2129, -4.878164e-02, 3.493353e-02, 7.396674e-03
-2130, -4.548324e-02, 3.913151e-02, 7.396674e-03
-2131, -5.031981e-02, 3.267900e-02, 1.440884e-02
-2132, -5.773928e-02, 1.631488e-02, 5.526214e-03
-2133, -5.619114e-02, 2.103700e-02, 5.526214e-03
-2134, -5.981981e-02, -4.646571e-03, 6.284142e-03
-2135, -5.999410e-02, 8.416217e-04, 6.284142e-03
-2136, -5.536564e-02, -2.312241e-02, 4.544932e-03
-2137, -5.708919e-02, -1.846144e-02, 4.544932e-03
-2138, -4.455786e-02, -4.018205e-02, 6.619292e-03
-2139, -4.795259e-02, -3.606313e-02, 6.619292e-03
-2140, -2.802913e-02, -5.305062e-02, 6.064186e-03
-2141, -3.243747e-02, -5.047584e-02, 6.064186e-03
-2142, -9.100394e-03, -5.930584e-02, 4.951945e-03
-2143, -1.397690e-02, -5.834935e-02, 4.951945e-03
-2144, 1.084626e-02, -5.901151e-02, 6.501356e-03
-2145, 5.925689e-03, -5.970667e-02, 6.501356e-03
-2146, 3.000493e-02, -5.195868e-02, 5.928630e-03
-2147, 2.555452e-02, -5.428597e-02, 5.928630e-03
-2148, 4.525490e-02, -3.939536e-02, 4.233345e-03
-2149, 4.183961e-02, -4.300520e-02, 4.233345e-03
-2150, 5.582206e-02, -2.199768e-02, 5.048662e-03
-2151, 5.381023e-02, -2.654166e-02, 5.048662e-03
-2152, 5.905685e-02, 1.059662e-02, 4.862828e-01
-2153, 5.907031e-02, -1.052134e-02, 1.349938e-02
-2154, 5.938542e-02, -8.565763e-03, 2.292804e-02
-2155, 5.915229e-02, -1.005021e-02, 1.002811e-01
-2156, 5.900465e-02, -1.088353e-02, 7.823880e-02
-2157, 5.904247e-02, -1.067646e-02, 5.588622e-02
-2158, 5.900066e-02, -1.090514e-02, 8.953815e-02
-2159, 5.896121e-02, -1.111649e-02, 1.109392e-01
-2160, 5.902971e-02, -1.074676e-02, 1.329039e-01
-2161, 5.863188e-02, -1.273979e-02, 1.558521e-01
-2162, 5.917983e-02, -9.886726e-03, 1.784310e-01
-2163, 5.915482e-02, -1.003530e-02, 1.992073e-01
-2164, 5.859337e-02, -1.291576e-02, 2.204305e-01
-2165, 5.875169e-02, -1.217535e-02, 2.441870e-01
-2166, 5.899025e-02, -1.096129e-02, 2.661833e-01
-2167, 5.909302e-02, -1.039303e-02, 2.880841e-01
-2168, 5.866387e-02, -1.259169e-02, 3.105835e-01
-2169, 5.907397e-02, -1.050074e-02, 3.332351e-01
-2170, 5.893115e-02, -1.127474e-02, 3.551449e-01
-2171, 5.877708e-02, -1.205215e-02, 3.771039e-01
-2172, 5.896996e-02, -1.106993e-02, 4.002266e-01
-2173, 5.904350e-02, -1.067076e-02, 4.216705e-01
-2174, 5.888576e-02, -1.150946e-02, 4.433601e-01
-2175, 5.902811e-02, -1.075557e-02, 4.657872e-01
-2176, 2.996801e-02, 5.197998e-02, 1.151922e-02
-2177, 1.223100e-02, 5.874013e-02, 9.600419e-03
-2178, -8.254822e-03, 5.942944e-02, 1.211126e-02
-2179, -2.823306e-02, 5.294237e-02, 1.148377e-02
-2180, -4.374413e-02, 4.106642e-02, 1.169563e-02
-2181, -5.533070e-02, 2.320589e-02, 1.253838e-02
-2182, -5.991911e-02, 3.114429e-03, 1.286582e-02
-2183, -5.779330e-02, -1.612250e-02, 9.110679e-03
-2184, -4.999299e-02, -3.317681e-02, 1.296544e-02
-2185, -3.489213e-02, -4.881126e-02, 1.227092e-02
-2186, -1.625595e-02, -5.775590e-02, 1.099060e-02
-2187, 3.268474e-03, -5.991091e-02, 1.264386e-02
-2188, 2.372347e-02, -5.511077e-02, 1.242057e-02
-2189, 4.060404e-02, -4.417366e-02, 9.549977e-03
-2190, 5.255182e-02, -2.895352e-02, 1.024842e-02
-2191, 5.891878e-02, -1.133920e-02, 1.220147e-01
-2192, 5.871502e-02, -1.235095e-02, 1.440205e-01
-2193, 5.876461e-02, -1.211282e-02, 1.676338e-01
-2194, 5.926484e-02, -9.363670e-03, 1.886707e-01
-2195, 5.895778e-02, -1.113462e-02, 2.095156e-01
-2196, 5.858082e-02, -1.297255e-02, 2.323447e-01
-2197, 5.909955e-02, -1.035580e-02, 2.553416e-01
-2198, 5.898196e-02, -1.100586e-02, 2.772865e-01
-2199, 5.877552e-02, -1.205980e-02, 2.990030e-01
-2200, 5.876190e-02, -1.212596e-02, 3.222138e-01
-2201, 5.893896e-02, -1.123386e-02, 3.440471e-01
-2202, 5.907299e-02, -1.050627e-02, 3.659843e-01
-2203, 5.869699e-02, -1.243638e-02, 3.889214e-01
-2204, 5.903222e-02, -1.073300e-02, 4.109322e-01
-2205, 5.902720e-02, -1.076056e-02, 4.322634e-01
-2206, 5.913788e-02, -1.013465e-02, 4.547666e-01
-2207, 2.396977e-03, 5.995210e-02, 1.134331e-02
-2208, -1.865802e-02, 5.702524e-02, 1.241834e-02
-2209, -3.655950e-02, 4.757523e-02, 9.562313e-03
-2210, -5.957099e-02, -7.162164e-03, 1.084989e-02
-2211, -5.478407e-02, -2.446845e-02, 1.089108e-02
-2212, -4.319068e-02, -4.164812e-02, 1.282603e-02
-2213, -2.564682e-02, -5.424243e-02, 1.210284e-02
-2214, -6.815331e-03, -5.961167e-02, 1.109445e-02
-2215, 1.374556e-02, -5.840428e-02, 1.299330e-02
-2216, 3.291939e-02, -5.016287e-02, 1.124526e-02
-2217, 4.687321e-02, -3.745534e-02, 9.433098e-03
-2218, 5.699394e-02, -1.875342e-02, 9.617323e-03
-2219, 5.917498e-02, -9.915748e-03, 3.354849e-02
-2220, 5.901387e-02, -1.083342e-02, 6.701585e-02
-2221, 4.651335e-02, 3.790130e-02, 1.149235e-02
-2222, 2.107975e-02, 5.617512e-02, 9.695446e-03
-2223, 3.877575e-02, 4.578691e-02, 1.189064e-02
-2224, -5.843803e-02, 1.360136e-02, 1.210789e-02
-2225, 5.911078e-02, 1.029154e-02, 1.350447e-02
-2226, 5.429233e-02, 2.554099e-02, 4.846749e-01
-2227, 5.184695e-02, 3.019758e-02, 4.844516e-01
-2228, 4.878685e-02, 3.492626e-02, 4.840495e-01
-2229, 4.557182e-02, 3.902831e-02, 4.839993e-01
-2230, 5.073907e-02, 3.202415e-02, 4.788076e-01
-2231, 4.177437e-02, 4.306858e-02, 4.839723e-01
-2232, 3.792638e-02, 4.649290e-02, 4.842519e-01
-2233, 4.392723e-02, 4.087051e-02, 4.783784e-01
-2234, 3.386629e-02, 4.952852e-02, 4.853073e-01
-2235, 2.931389e-02, 5.235165e-02, 4.852843e-01
-2236, 3.604640e-02, 4.796517e-02, 4.794068e-01
-2237, 2.500089e-02, 5.454315e-02, 4.840029e-01
-2238, 2.038415e-02, 5.643125e-02, 4.836921e-01
-2239, 2.766947e-02, 5.323909e-02, 4.791809e-01
-2240, 1.527755e-02, 5.802238e-02, 4.834965e-01
-2241, 1.013139e-02, 5.913844e-02, 4.835743e-01
-2242, 1.827334e-02, 5.714967e-02, 4.777040e-01
-2243, 4.791820e-03, 5.980835e-02, 4.840660e-01
-2244, -4.348037e-04, 5.999842e-02, 4.841475e-01
-2245, 7.812320e-03, 5.948922e-02, 4.780002e-01
-2246, -5.913131e-03, 5.970791e-02, 4.842068e-01
-2247, -1.102764e-02, 5.897789e-02, 4.841850e-01
-2248, -3.035308e-03, 5.992318e-02, 4.785512e-01
-2249, -1.616795e-02, 5.778060e-02, 4.837139e-01
-2250, -2.115217e-02, 5.614789e-02, 4.834434e-01
-2251, -1.368269e-02, 5.841904e-02, 4.781393e-01
-2252, -2.603586e-02, 5.405677e-02, 4.831198e-01
-2253, -3.063549e-02, 5.158941e-02, 4.830571e-01
-2254, -2.373120e-02, 5.510744e-02, 4.773447e-01
-2255, -3.511030e-02, 4.865457e-02, 4.829222e-01
-2256, -3.904585e-02, 4.555680e-02, 4.829956e-01
-2257, -3.310317e-02, 5.004178e-02, 4.768861e-01
-2258, -4.287839e-02, 4.196956e-02, 4.833783e-01
-2259, -4.627979e-02, 3.818614e-02, 4.837762e-01
-2260, -4.138582e-02, 4.344208e-02, 4.771340e-01
-2261, -4.912561e-02, 3.444815e-02, 4.850964e-01
-2262, -5.188178e-02, 3.013769e-02, 4.851822e-01
-2263, -4.798942e-02, 3.601410e-02, 4.788370e-01
-2264, -5.414991e-02, 2.584159e-02, 4.843721e-01
-2265, -5.613406e-02, 2.118884e-02, 4.841130e-01
-2266, -5.309491e-02, 2.794514e-02, 4.793471e-01
-2267, -5.777868e-02, 1.617481e-02, 4.839499e-01
-2268, -5.892785e-02, 1.129194e-02, 4.840958e-01
-2269, -5.703814e-02, 1.861857e-02, 4.783738e-01
-2270, -5.964643e-02, 6.504091e-03, 4.849567e-01
-2271, -5.998635e-02, 1.279563e-03, 4.849008e-01
-2272, -5.935440e-02, 8.778142e-03, 4.790714e-01
-2273, -5.989877e-02, -3.483886e-03, 4.835572e-01
-2274, -5.939915e-02, -8.469975e-03, 4.832559e-01
-2275, -5.999469e-02, -7.985070e-04, 4.785887e-01
-2276, -5.844694e-02, -1.356299e-02, 4.834339e-01
-2277, -5.708892e-02, -1.846225e-02, 4.834604e-01
-2278, -5.904010e-02, -1.068954e-02, 4.774231e-01
-2279, -5.520717e-02, -2.349826e-02, 4.836987e-01
-2280, -5.301167e-02, -2.810273e-02, 4.838320e-01
-2281, -5.625612e-02, -2.086262e-02, 4.778394e-01
-2282, -5.045799e-02, -3.246523e-02, 4.840770e-01
-2283, -4.747638e-02, -3.668778e-02, 4.841134e-01
-2284, -5.179770e-02, -3.028198e-02, 4.783228e-01
-2285, -4.406801e-02, -4.071867e-02, 4.840079e-01
-2286, -4.041616e-02, -4.434562e-02, 4.839060e-01
-2287, -4.583963e-02, -3.871341e-02, 4.784623e-01
-2288, -3.653589e-02, -4.759337e-02, 4.835003e-01
-2289, -3.240443e-02, -5.049706e-02, 4.834656e-01
-2290, -3.852044e-02, -4.600191e-02, 4.779512e-01
-2291, -2.798684e-02, -5.307294e-02, 4.837214e-01
-2292, -2.336593e-02, -5.526331e-02, 4.837155e-01
-2293, -3.020245e-02, -5.184411e-02, 4.778013e-01
-2294, -1.834110e-02, -5.712796e-02, 4.836682e-01
-2295, -1.343941e-02, -5.847548e-02, 4.836382e-01
-2296, -2.073653e-02, -5.630272e-02, 4.780098e-01
-2297, -8.378182e-03, -5.941217e-02, 4.832626e-01
-2298, -3.463241e-03, -5.989997e-02, 4.833872e-01
-2299, -1.060703e-02, -5.905498e-02, 4.775868e-01
-2300, 1.316227e-03, -5.998556e-02, 4.843793e-01
-2301, 6.423850e-03, -5.965513e-02, 4.843438e-01
-2302, -7.328010e-04, -5.999552e-02, 4.782033e-01
-2303, 1.132515e-02, -5.892148e-02, 4.830843e-01
-2304, 1.615212e-02, -5.778502e-02, 4.829445e-01
-2305, 8.972209e-03, -5.932537e-02, 4.779358e-01
-2306, 2.123028e-02, -5.611840e-02, 4.831075e-01
-2307, 2.566181e-02, -5.423534e-02, 4.835613e-01
-2308, 1.897812e-02, -5.691951e-02, 4.768392e-01
-2309, 2.985112e-02, -5.204720e-02, 4.853431e-01
-2310, 3.413156e-02, -4.934609e-02, 4.856564e-01
-2311, 2.822319e-02, -5.294763e-02, 4.787839e-01
-2312, 3.801364e-02, -4.642158e-02, 4.851732e-01
-2313, 4.177326e-02, -4.306965e-02, 4.850404e-01
-2314, 3.628968e-02, -4.778137e-02, 4.800824e-01
-2315, 4.532826e-02, -3.931093e-02, 4.851893e-01
-2316, 4.830172e-02, -3.559415e-02, 4.855056e-01
-2317, 4.373883e-02, -4.107207e-02, 4.797481e-01
-2318, 5.084686e-02, -3.185273e-02, 4.866347e-01
-2319, 5.331913e-02, -2.751492e-02, 4.866734e-01
-2320, 4.978031e-02, -3.349508e-02, 4.810260e-01
-2321, 5.527644e-02, -2.333486e-02, 4.858499e-01
-2322, 5.688119e-02, -1.909267e-02, 4.859285e-01
-2323, 5.428777e-02, -2.555070e-02, 4.813316e-01
-2324, 5.805563e-02, -1.515072e-02, 4.873790e-01
-2325, 5.905857e-02, -1.058701e-02, 4.872747e-01
-2326, 5.920779e-02, -9.717921e-03, 4.826443e-01
-2327, 5.741888e-02, -1.740899e-02, 4.819587e-01
-2328, 4.499737e-02, 3.968925e-02, 1.765686e-02
-2329, 4.847793e-02, 3.535379e-02, 1.735636e-02
-2330, 5.799340e-02, -1.538719e-02, 1.047579e-01
-2331, 5.774816e-02, -1.628344e-02, 9.955691e-02
-2332, 5.729263e-02, -1.782007e-02, 6.982660e-02
-2333, 5.731926e-02, -1.773421e-02, 6.436102e-02
-2334, 5.734554e-02, -1.764905e-02, 9.281832e-02
-2335, 5.736343e-02, -1.759082e-02, 8.727634e-02
-2336, 5.550319e-02, -2.279027e-02, 9.729510e-02
-2337, 5.778452e-02, -1.615392e-02, 5.872562e-02
-2338, 5.780324e-02, -1.608683e-02, 5.306157e-02
-2339, 5.543520e-02, -2.295514e-02, 6.153637e-02
-2340, 5.744477e-02, -1.732335e-02, 1.102150e-01
-2341, 5.768727e-02, -1.649784e-02, 8.131755e-02
-2342, 5.767655e-02, -1.653528e-02, 7.556018e-02
-2343, 5.531723e-02, -2.323798e-02, 7.290535e-02
-2344, 5.539477e-02, -2.305255e-02, 8.459772e-02
-2345, 5.747395e-02, -1.722628e-02, 1.330778e-01
-2346, 5.780241e-02, -1.608980e-02, 1.278070e-01
-2347, 5.633991e-02, -2.063528e-02, 1.591729e-01
-2348, 5.632125e-02, -2.068614e-02, 1.531870e-01
-2349, 5.694824e-02, -1.889176e-02, 1.723587e-01
-2350, 5.676078e-02, -1.944771e-02, 1.665630e-01
-2351, 5.820278e-02, -1.457520e-02, 1.841720e-01
-2352, 5.777247e-02, -1.619695e-02, 1.791706e-01
-2353, 5.526008e-02, -2.337357e-02, 1.780998e-01
-2354, 5.791327e-02, -1.568608e-02, 1.894103e-01
-2355, 5.758824e-02, -1.684028e-02, 2.027194e-01
-2356, 5.745530e-02, -1.728839e-02, 1.974211e-01
-2357, 5.712355e-02, -1.835483e-02, 2.077294e-01
-2358, 5.635758e-02, -2.058697e-02, 2.350041e-01
-2359, 5.629706e-02, -2.075189e-02, 2.289948e-01
-2360, 5.698393e-02, -1.878382e-02, 2.479046e-01
-2361, 5.678045e-02, -1.939023e-02, 2.420716e-01
-2362, 5.799059e-02, -1.539777e-02, 2.600660e-01
-2363, 5.766749e-02, -1.656686e-02, 2.547443e-01
-2364, 5.515831e-02, -2.361273e-02, 2.526290e-01
-2365, 5.749457e-02, -1.715733e-02, 2.655861e-01
-2366, 5.797248e-02, -1.546581e-02, 2.831189e-01
-2367, 5.748740e-02, -1.718136e-02, 2.775358e-01
-2368, 5.766264e-02, -1.658372e-02, 2.883334e-01
-2369, 5.658016e-02, -1.996712e-02, 3.133524e-01
-2370, 5.658241e-02, -1.996075e-02, 3.074763e-01
-2371, 5.695100e-02, -1.888344e-02, 3.260329e-01
-2372, 5.679724e-02, -1.934099e-02, 3.202788e-01
-2373, 5.789943e-02, -1.573710e-02, 3.380808e-01
-2374, 5.758093e-02, -1.686525e-02, 3.328136e-01
-2375, 5.503593e-02, -2.389658e-02, 3.308786e-01
-2376, 5.736695e-02, -1.757933e-02, 3.436257e-01
-2377, 5.788757e-02, -1.578067e-02, 3.611187e-01
-2378, 5.736592e-02, -1.758270e-02, 3.555659e-01
-2379, 5.759005e-02, -1.683408e-02, 3.664053e-01
-2380, 5.676277e-02, -1.944190e-02, 3.926016e-01
-2381, 5.673456e-02, -1.952407e-02, 3.866172e-01
-2382, 5.747307e-02, -1.722924e-02, 4.062589e-01
-2383, 5.708427e-02, -1.847664e-02, 4.009381e-01
-2384, 5.718885e-02, -1.815036e-02, 4.116438e-01
-2385, 5.755898e-02, -1.694000e-02, 4.265071e-01
-2386, 5.726054e-02, -1.792291e-02, 4.211537e-01
-2387, 5.723321e-02, -1.800999e-02, 4.317466e-01
-2388, 5.798974e-02, -1.540097e-02, 4.591424e-01
-2389, 5.771371e-02, -1.640512e-02, 4.535931e-01
-2390, 5.753812e-02, -1.701073e-02, 4.646137e-01
-2391, 9.030468e-04, 5.999320e-02, 1.847777e-02
-2392, 6.149571e-03, 5.968402e-02, 1.799443e-02
-2393, 2.612187e-02, 5.401526e-02, 1.815536e-02
-2394, 3.076790e-02, 5.151054e-02, 1.862456e-02
-2395, 5.929155e-02, -9.193052e-03, 4.765690e-01
-2396, 5.755305e-02, -1.696015e-02, 4.735323e-02
-2397, 5.758885e-02, -1.683818e-02, 4.179331e-02
-2398, 5.571370e-02, -2.227068e-02, 5.019263e-02
-2399, 1.651462e-02, 5.768247e-02, 1.441562e-02
-2400, 2.084631e-02, 5.626217e-02, 1.577020e-02
-2401, 2.171348e-02, 5.593322e-02, 2.287553e-02
-2402, 1.198698e-02, 5.879041e-02, 1.567517e-02
-2403, 5.180144e-02, 3.027558e-02, 1.644983e-02
-2404, 5.438143e-02, 2.535075e-02, 1.589209e-02
-2405, 5.057930e-02, 3.227591e-02, 2.261435e-02
-2406, -5.852511e-02, 1.322164e-02, 2.030409e-02
-2407, -5.718896e-02, 1.815000e-02, 1.924863e-02
-2408, 3.612562e-02, 4.790553e-02, 1.875046e-02
-2409, 4.036041e-02, 4.439637e-02, 1.865267e-02
-2410, 4.268196e-02, 4.216931e-02, 2.451668e-02
-2411, 3.255859e-02, 5.039780e-02, 2.538659e-02
-2412, -3.167344e-02, 5.095874e-02, 1.778933e-02
-2413, -2.718633e-02, 5.348741e-02, 1.874639e-02
-2414, -5.844367e-02, -1.357710e-02, 1.621375e-02
-2415, -5.934148e-02, -8.865021e-03, 1.793215e-02
-2416, -5.548021e-02, 2.284614e-02, 2.073459e-02
-2417, -5.999892e-02, -3.602378e-04, 1.996260e-02
-2418, -5.978025e-02, 5.130471e-03, 2.026013e-02
-2419, -5.919248e-02, 9.810732e-03, 2.740087e-02
-2420, -5.960636e-02, -6.861637e-03, 2.532646e-02
-2421, 5.813194e-02, 1.485522e-02, 1.462562e-02
-2422, 5.876971e-02, 1.208804e-02, 1.877080e-02
-2423, 5.650186e-02, 2.018762e-02, 1.498415e-02
-2424, -4.957129e-02, -3.380366e-02, 2.058720e-02
-2425, -5.241687e-02, -2.919712e-02, 2.031406e-02
-2426, -3.253369e-02, -5.041388e-02, 1.840691e-02
-2427, -3.702367e-02, -4.721491e-02, 1.854945e-02
-2428, -6.981088e-03, -5.959249e-02, 1.827478e-02
-2429, -1.173603e-02, -5.884102e-02, 1.708422e-02
-2430, 2.745191e-02, -5.335160e-02, 1.943797e-02
-2431, 2.272421e-02, -5.553026e-02, 2.000129e-02
-2432, 4.412663e-02, -4.065514e-02, 1.503783e-02
-2433, 4.095260e-02, -4.385071e-02, 1.612112e-02
-2434, 4.716837e-02, -3.708294e-02, 1.600424e-02
-2435, 5.368005e-02, -2.680395e-02, 1.601699e-02
-2436, 5.097827e-02, -3.164200e-02, 1.616808e-02
-2437, 5.788323e-02, -1.579659e-02, 1.457708e-02
-2438, 5.615976e-02, -2.112064e-02, 1.505708e-02
-2439, 5.498788e-02, -2.400694e-02, 2.097675e-02
-2440, 5.857860e-02, -1.298261e-02, 1.893914e-02
-2441, 5.729800e-02, -1.780277e-02, 1.221886e-01
-2442, 5.873671e-02, 1.224739e-02, 4.812826e-01
-2443, 5.804098e-02, 1.520675e-02, 4.855512e-01
-2444, 5.641774e-02, 2.042154e-02, 4.853455e-01
-2445, 5.859338e-02, 1.291574e-02, 4.764784e-01
-2446, 5.837311e-02, -1.387732e-02, 2.400574e-02
-2447, 5.842267e-02, 1.366716e-02, 2.925287e-02
-2448, 5.830587e-02, 1.415717e-02, 3.471307e-02
-2449, 5.811399e-02, 1.492528e-02, 4.040195e-02
-2450, 5.807792e-02, 1.506502e-02, 4.606726e-02
-2451, 5.680335e-02, 1.932304e-02, 3.673087e-02
-2452, 5.788782e-02, 1.577975e-02, 5.201683e-02
-2453, 5.781884e-02, 1.603063e-02, 5.757681e-02
-2454, 5.629174e-02, 2.076631e-02, 4.836930e-02
-2455, 5.771693e-02, 1.639379e-02, 6.345834e-02
-2456, 5.770112e-02, 1.644934e-02, 6.905744e-02
-2457, 5.589550e-02, 2.181039e-02, 6.020039e-02
-2458, 5.771710e-02, 1.639318e-02, 7.471935e-02
-2459, 5.772579e-02, 1.636256e-02, 8.038179e-02
-2460, 5.577883e-02, 2.210707e-02, 7.174382e-02
-2461, 5.775822e-02, 1.624772e-02, 8.611383e-02
-2462, 5.782338e-02, 1.601426e-02, 9.155244e-02
-2463, 5.584407e-02, 2.194175e-02, 8.313778e-02
-2464, 5.788036e-02, 1.580709e-02, 9.690961e-02
-2465, 5.788578e-02, 1.578722e-02, 1.024500e-01
-2466, 5.596541e-02, 2.163036e-02, 9.422699e-02
-2467, 5.794441e-02, 1.557066e-02, 1.080716e-01
-2468, 5.789717e-02, 1.574541e-02, 1.137722e-01
-2469, 5.612226e-02, 2.122009e-02, 1.052058e-01
-2470, 5.776097e-02, 1.623794e-02, 1.194192e-01
-2471, 5.772606e-02, 1.636159e-02, 1.250002e-01
-2472, 5.602024e-02, 2.148798e-02, 1.164745e-01
-2473, 5.753291e-02, 1.702834e-02, 1.304091e-01
-2474, 5.749240e-02, 1.716460e-02, 1.358159e-01
-2475, 5.557734e-02, 2.260882e-02, 1.275305e-01
-2476, 5.758046e-02, 1.686685e-02, 1.413260e-01
-2477, 5.759752e-02, 1.680851e-02, 1.468734e-01
-2478, 5.543164e-02, 2.296375e-02, 1.384495e-01
-2479, 5.765775e-02, 1.660071e-02, 1.525943e-01
-2480, 5.768378e-02, 1.651006e-02, 1.582267e-01
-2481, 5.563114e-02, 2.247613e-02, 1.496806e-01
-2482, 5.772792e-02, 1.635502e-02, 1.636878e-01
-2483, 5.777602e-02, 1.618430e-02, 1.691443e-01
-2484, 5.577147e-02, 2.212562e-02, 1.608626e-01
-2485, 5.779251e-02, 1.612530e-02, 1.748242e-01
-2486, 5.777924e-02, 1.617280e-02, 1.803936e-01
-2487, 5.585312e-02, 2.191869e-02, 1.720036e-01
-2488, 5.771521e-02, 1.639985e-02, 1.859264e-01
-2489, 5.768559e-02, 1.650373e-02, 1.915266e-01
-2490, 5.578908e-02, 2.208117e-02, 1.832162e-01
-2491, 5.776052e-02, 1.623952e-02, 1.970594e-01
-2492, 5.778911e-02, 1.613749e-02, 2.026712e-01
-2493, 5.580333e-02, 2.204515e-02, 1.942819e-01
-2494, 5.779150e-02, 1.612893e-02, 2.083497e-01
-2495, 5.777857e-02, 1.617520e-02, 2.138446e-01
-2496, 5.590688e-02, 2.178121e-02, 2.054932e-01
-2497, 5.775277e-02, 1.626708e-02, 2.192437e-01
-2498, 5.773528e-02, 1.632903e-02, 2.247866e-01
-2499, 5.587540e-02, 2.186182e-02, 2.165707e-01
-2500, 5.770342e-02, 1.644125e-02, 2.304415e-01
-2501, 5.769187e-02, 1.648174e-02, 2.360473e-01
-2502, 5.579778e-02, 2.205919e-02, 2.276246e-01
-2503, 5.763758e-02, 1.667061e-02, 2.414992e-01
-2504, 5.769361e-02, 1.647564e-02, 2.468666e-01
-2505, 5.568188e-02, 2.235013e-02, 2.387312e-01
-2506, 5.781821e-02, 1.603292e-02, 2.523179e-01
-2507, 5.783249e-02, 1.598132e-02, 2.578673e-01
-2508, 5.577946e-02, 2.210547e-02, 2.496343e-01
-2509, 5.787613e-02, 1.582257e-02, 2.635499e-01
-2510, 5.785683e-02, 1.589301e-02, 2.691931e-01
-2511, 5.600654e-02, 2.152365e-02, 2.607682e-01
-2512, 5.783407e-02, 1.597560e-02, 2.746294e-01
-2513, 5.784537e-02, 1.593464e-02, 2.801968e-01
-2514, 5.603482e-02, 2.144992e-02, 2.718871e-01
-2515, 5.783618e-02, 1.596798e-02, 2.857637e-01
-2516, 5.782569e-02, 1.600591e-02, 2.912208e-01
-2517, 5.599172e-02, 2.156218e-02, 2.828903e-01
-2518, 5.784209e-02, 1.594657e-02, 2.966065e-01
-2519, 5.783431e-02, 1.597475e-02, 3.021573e-01
-2520, 5.600141e-02, 2.153700e-02, 2.938430e-01
-2521, 5.781393e-02, 1.604836e-02, 3.078106e-01
-2522, 5.780444e-02, 1.608251e-02, 3.134358e-01
-2523, 5.599609e-02, 2.155081e-02, 3.048821e-01
-2524, 5.777792e-02, 1.617753e-02, 3.188609e-01
-2525, 5.779461e-02, 1.611778e-02, 3.243091e-01
-2526, 5.593299e-02, 2.171406e-02, 3.159605e-01
-2527, 5.773362e-02, 1.633490e-02, 3.299636e-01
-2528, 5.768978e-02, 1.648907e-02, 3.355474e-01
-2529, 5.581486e-02, 2.201594e-02, 3.270402e-01
-2530, 5.755656e-02, 1.694824e-02, 3.411360e-01
-2531, 5.751408e-02, 1.709182e-02, 3.467807e-01
-2532, 5.555284e-02, 2.266897e-02, 3.382833e-01
-2533, 5.752312e-02, 1.706137e-02, 3.524307e-01
-2534, 5.758063e-02, 1.686627e-02, 3.578791e-01
-2535, 5.538267e-02, 2.308160e-02, 3.495218e-01
-2536, 5.774399e-02, 1.629819e-02, 3.634025e-01
-2537, 5.774974e-02, 1.627784e-02, 3.689644e-01
-2538, 5.561929e-02, 2.250544e-02, 3.606951e-01
-2539, 5.779601e-02, 1.611275e-02, 3.746783e-01
-2540, 5.781879e-02, 1.603081e-02, 3.802721e-01
-2541, 5.590081e-02, 2.179676e-02, 3.719325e-01
-2542, 5.785446e-02, 1.590162e-02, 3.857123e-01
-2543, 5.785442e-02, 1.590177e-02, 3.913739e-01
-2544, 5.601106e-02, 2.151187e-02, 3.830866e-01
-2545, 5.785827e-02, 1.588775e-02, 3.970512e-01
-2546, 5.789525e-02, 1.575247e-02, 4.025386e-01
-2547, 5.606416e-02, 2.137312e-02, 3.942041e-01
-2548, 5.787706e-02, 1.581915e-02, 4.080135e-01
-2549, 5.782681e-02, 1.600186e-02, 4.137381e-01
-2550, 5.604470e-02, 2.142410e-02, 4.053563e-01
-2551, 5.777882e-02, 1.617431e-02, 4.195621e-01
-2552, 5.778603e-02, 1.614853e-02, 4.250822e-01
-2553, 5.595562e-02, 2.165567e-02, 4.166551e-01
-2554, 5.772644e-02, 1.636027e-02, 4.308415e-01
-2555, 5.769151e-02, 1.648302e-02, 4.364788e-01
-2556, 5.581039e-02, 2.202727e-02, 4.282383e-01
-2557, 5.774262e-02, 1.630305e-02, 4.424700e-01
-2558, 5.779514e-02, 1.611590e-02, 4.481866e-01
-2559, 5.579831e-02, 2.205784e-02, 4.399888e-01
-2560, 5.799239e-02, 1.539099e-02, 4.542171e-01
-2561, 5.806023e-02, 1.513308e-02, 4.598686e-01
-2562, 5.613645e-02, 2.118252e-02, 4.520105e-01
-2563, 5.827878e-02, 1.426828e-02, 4.655601e-01
-2564, 5.836327e-02, 1.391864e-02, 4.709149e-01
-2565, 5.729502e-02, 1.781239e-02, 4.749874e-01
-2566, 5.669547e-02, 1.963731e-02, 4.637324e-01
-2567, 5.864677e-02, 1.267108e-02, 2.367785e-02
-2568, -5.208958e-02, 2.977709e-02, 2.294024e-02
-2569, -4.901154e-02, 3.461024e-02, 2.332475e-02
-2570, -5.455025e-02, 2.498541e-02, 2.965049e-02
-2571, 5.859340e-02, -1.291562e-02, 4.773339e-01
-2572, 5.579334e-02, 2.207040e-02, 4.798803e-01
-2573, 5.597606e-02, -2.160278e-02, 3.495528e-01
-2574, 5.414722e-02, -2.584721e-02, 3.435864e-01
-2575, 5.414570e-02, -2.585040e-02, 3.555267e-01
-2576, 5.602236e-02, -2.148244e-02, 1.157941e-01
-2577, 5.430634e-02, -2.551120e-02, 1.096128e-01
-2578, 5.409126e-02, -2.596411e-02, 1.215864e-01
-2579, -5.552066e-02, -2.274768e-02, 2.561592e-02
-2580, -5.580268e-02, -2.204679e-02, 1.799415e-02
-2581, 5.631209e-02, -2.071108e-02, 2.714284e-01
-2582, 5.458166e-02, -2.491671e-02, 2.653111e-01
-2583, 5.457124e-02, -2.493952e-02, 2.772608e-01
-2584, 5.354497e-02, -2.707280e-02, 1.638978e-01
-2585, 5.663708e-02, -1.980508e-02, 1.457931e-01
-2586, 5.678460e-02, -1.937805e-02, 1.399474e-01
-2587, 5.477885e-02, -2.448014e-02, 1.348504e-01
-2588, 5.339799e-02, -2.736156e-02, 1.491139e-01
-2589, 5.569855e-02, -2.230854e-02, 1.929224e-01
-2590, 5.644140e-02, -2.035605e-02, 2.153963e-01
-2591, 5.418315e-02, -2.577182e-02, 2.086000e-01
-2592, 5.636164e-02, -2.057586e-02, 2.213011e-01
-2593, 5.364790e-02, -2.686825e-02, 2.387217e-01
-2594, 5.696787e-02, -1.883247e-02, 2.949706e-01
-2595, 5.512526e-02, -2.368979e-02, 2.900054e-01
-2596, 5.679713e-02, -1.934131e-02, 3.006750e-01
-2597, 5.387137e-02, -2.641734e-02, 3.171716e-01
-2598, 5.491305e-02, -2.417762e-02, 4.164804e-01
-2599, 5.700663e-02, -1.871480e-02, 3.733309e-01
-2600, 5.509076e-02, -2.376989e-02, 3.684654e-01
-2601, 5.685530e-02, -1.916964e-02, 3.791640e-01
-2602, 5.439498e-02, -2.532165e-02, 3.986339e-01
-2603, 5.709766e-02, -1.843523e-02, 4.402382e-01
-2604, 5.482897e-02, -2.436769e-02, 4.344819e-01
-2605, 5.720614e-02, -1.809578e-02, 4.460954e-01
-2606, 1.051901e-02, 5.907072e-02, 2.280963e-02
-2607, -5.126417e-03, 5.978060e-02, 1.831077e-02
-2608, -1.369782e-03, 5.998436e-02, 2.496189e-02
-2609, -1.049973e-02, 5.907415e-02, 1.859538e-02
-2610, 5.585839e-02, 2.190525e-02, 2.079988e-02
-2611, -2.116493e-02, 5.614308e-02, 2.037174e-02
-2612, -1.615831e-02, 5.778329e-02, 2.034926e-02
-2613, -1.310536e-02, 5.855126e-02, 2.654878e-02
-2614, -2.483251e-02, 5.462002e-02, 2.667730e-02
-2615, -4.644545e-02, 3.798447e-02, 3.239966e-02
-2616, -4.421997e-02, 4.055359e-02, 2.386826e-02
-2617, -3.951659e-02, 4.514907e-02, 1.382759e-02
-2618, -3.580983e-02, 4.814204e-02, 1.479200e-02
-2619, -3.485605e-02, 4.883703e-02, 2.205461e-02
-2620, -4.309553e-02, 4.174656e-02, 1.692531e-02
-2621, -2.741893e-02, -5.336855e-02, 1.939817e-02
-2622, -2.976005e-02, -5.209932e-02, 2.567671e-02
-2623, -2.267624e-02, -5.554987e-02, 1.937264e-02
-2624, -4.520993e-02, -3.944696e-02, 2.052702e-02
-2625, -4.813482e-02, -3.581954e-02, 2.787564e-02
-2626, -4.143607e-02, -4.339414e-02, 2.011446e-02
-2627, -5.730794e-02, -1.777077e-02, 1.619294e-02
-2628, -3.932761e-02, -4.531378e-02, 2.625045e-02
-2629, -1.641651e-02, -5.771047e-02, 1.817093e-02
-2630, 5.128675e-03, -5.978040e-02, 1.978302e-02
-2631, -1.499778e-04, -5.999981e-02, 1.942417e-02
-2632, 1.672824e-02, -5.762088e-02, 2.044030e-02
-2633, 1.156633e-02, -5.887461e-02, 2.044971e-02
-2634, 3.638384e-02, -4.770971e-02, 1.662926e-02
-2635, 3.207657e-02, -5.070595e-02, 1.724126e-02
-2636, 3.115550e-02, -5.127704e-02, 2.482197e-02
-2637, 4.021413e-02, -4.452891e-02, 2.211711e-02
-2638, 4.862987e-02, -3.514450e-02, 2.177281e-02
-2639, 5.787352e-02, -1.583210e-02, 3.561761e-02
-2640, 5.799020e-02, -1.539924e-02, 3.006375e-02
-2641, 5.667628e-02, -1.969262e-02, 2.607486e-02
-2642, 5.576446e-02, -2.214328e-02, 3.830857e-02
-2643, 5.736112e-02, 1.759836e-02, 2.546697e-02
-2644, -1.830782e-02, -5.713864e-02, 2.546626e-02
-2645, -5.125832e-03, -5.978065e-02, 2.541394e-02
-2646, 5.315478e-02, -2.783108e-02, 2.239606e-01
-2647, 5.386824e-02, -2.642371e-02, 3.034439e-01
-2648, 5.412051e-02, -2.590310e-02, 3.828441e-01
-2649, 5.535134e-02, -2.315662e-02, 4.504712e-01
-2650, -4.004033e-02, 4.468526e-02, 2.600023e-02
-2651, 2.064556e-02, -5.633614e-02, 2.745770e-02
-2652, 8.193443e-03, -5.943793e-02, 2.723002e-02
-2653, -1.926767e-02, 5.682215e-02, 1.713751e-01
-2654, -2.069545e-02, 5.631783e-02, 1.828700e-01
-2655, 5.540666e-02, 2.302394e-02, 4.743168e-01
-2656, 4.588783e-02, 3.865626e-02, 4.719718e-01
-2657, 4.212338e-02, 4.272729e-02, 4.719448e-01
-2658, 3.655438e-02, 4.757917e-02, 4.723438e-01
-2659, 3.240748e-02, 5.049510e-02, 4.733992e-01
-2660, 3.885452e-02, 4.572009e-02, 4.659371e-01
-2661, 2.823400e-02, 5.294187e-02, 4.721178e-01
-2662, -9.210102e-03, 5.928890e-02, 1.900741e-01
-2663, 2.215918e-02, 5.575814e-02, 4.707655e-01
-2664, 1.710547e-02, 5.751002e-02, 4.705700e-01
-2665, 2.714977e-02, 5.350598e-02, 4.649838e-01
-2666, 1.062500e-02, 5.905175e-02, 4.708270e-01
-2667, 5.291215e-03, 5.976624e-02, 4.713187e-01
-2668, 1.465971e-02, 5.818155e-02, 4.638885e-01
-2669, -1.338549e-04, 5.999985e-02, 4.727652e-01
-2670, -5.613570e-03, 5.973682e-02, 4.728245e-01
-2671, 2.711985e-03, 5.993868e-02, 4.655920e-01
-2672, -1.073671e-02, 5.903154e-02, 4.716649e-01
-2673, -1.588286e-02, 5.785961e-02, 4.711938e-01
-2674, -7.869365e-03, 5.948170e-02, 4.658790e-01
-2675, -2.122084e-02, 5.612198e-02, 4.704410e-01
-2676, -2.610196e-02, 5.402488e-02, 4.701174e-01
-2677, -1.838053e-02, 5.711529e-02, 4.639665e-01
-2678, -3.115409e-02, 5.127790e-02, 4.699042e-01
-2679, -3.559908e-02, 4.829809e-02, 4.697692e-01
-2680, -2.880894e-02, 5.263122e-02, 4.630005e-01
-2681, -4.065151e-02, 4.412998e-02, 4.699014e-01
-2682, -4.435319e-02, 4.040785e-02, 4.702842e-01
-2683, -3.892421e-02, 4.566077e-02, 4.629194e-01
-2684, -4.855879e-02, 3.524265e-02, 4.712924e-01
-2685, -5.116732e-02, 3.133536e-02, 4.726126e-01
-2686, -4.796097e-02, 3.605198e-02, 4.640598e-01
-2687, -5.353468e-02, 2.709313e-02, 4.718025e-01
-2688, -5.197776e-02, 2.997187e-02, 3.874210e-01
-2689, -5.693563e-02, 1.892971e-02, 3.878988e-01
-2690, -5.627262e-02, 2.081808e-02, 4.721525e-01
-2691, -5.788412e-02, 1.579331e-02, 4.719893e-01
-2692, -5.480133e-02, 2.442979e-02, 4.654180e-01
-2693, -5.931618e-02, 9.032769e-03, 4.714218e-01
-2694, -5.985134e-02, 4.220965e-03, 4.722826e-01
-2695, -5.892095e-02, 1.132791e-02, 4.652005e-01
-2696, -5.999756e-02, -5.410443e-04, 4.709390e-01
-2697, -2.215189e-02, -5.576104e-02, 3.515758e-01
-2698, -2.387285e-02, -5.504623e-02, 3.395049e-01
-2699, -5.953251e-02, -7.475273e-03, 4.696770e-01
-2700, -5.866562e-02, -1.258350e-02, 4.698550e-01
-2701, -5.994909e-02, -2.471064e-03, 4.633709e-01
-2702, -5.718810e-02, -1.815272e-02, 4.717417e-01
-2703, -5.533366e-02, -2.319885e-02, 4.719800e-01
-2704, -5.808756e-02, -1.502782e-02, 4.639956e-01
-2705, -5.297692e-02, -2.816818e-02, 4.710368e-01
-2706, -5.041785e-02, -3.252753e-02, 4.712818e-01
-2707, -5.426146e-02, -2.560651e-02, 4.649391e-01
-2708, -4.758452e-02, -3.654741e-02, 4.727071e-01
-2709, -4.418808e-02, -4.058835e-02, 4.726017e-01
-2710, -4.901987e-02, -3.459844e-02, 4.654211e-01
-2711, -4.071788e-02, -4.406875e-02, 4.709668e-01
-2712, -3.685986e-02, -4.734291e-02, 4.705611e-01
-2713, -4.271646e-02, -4.213436e-02, 4.652115e-01
-2714, -3.214508e-02, -5.066255e-02, 4.705944e-01
-2715, -2.771434e-02, -5.321574e-02, 4.708502e-01
-2716, -3.457737e-02, -4.903474e-02, 4.636099e-01
-2717, -2.299352e-02, -5.541929e-02, 4.722650e-01
-2718, -1.795627e-02, -5.725009e-02, 4.722177e-01
-2719, -2.507679e-02, -5.450830e-02, 4.650580e-01
-2720, -1.256843e-02, -5.866886e-02, 4.706492e-01
-2721, -7.493836e-03, -5.953018e-02, 4.702736e-01
-2722, -1.492765e-02, -5.811338e-02, 4.649044e-01
-2723, -3.948997e-04, -5.999870e-02, 4.703505e-01
-2724, 4.382690e-03, -5.983972e-02, 4.713425e-01
-2725, -2.393406e-03, -5.995224e-02, 4.634128e-01
-2726, 9.306183e-03, -5.927390e-02, 4.700830e-01
-2727, -3.377894e-02, 4.958814e-02, 1.317466e-01
-2728, -2.676590e-02, 5.369904e-02, 1.463004e-01
-2729, 1.721350e-02, -5.747778e-02, 4.690070e-01
-2730, 2.226011e-02, -5.571793e-02, 4.691699e-01
-2731, 1.274167e-02, -5.863147e-02, 4.624137e-01
-2732, 2.919132e-02, -5.242010e-02, 4.714993e-01
-2733, 3.322680e-02, -4.995978e-02, 4.732810e-01
-2734, 2.756062e-02, -5.329552e-02, 4.636671e-01
-2735, 3.716152e-02, -4.710649e-02, 4.727978e-01
-2736, -5.002280e-02, 3.313185e-02, 4.002719e-01
-2737, 4.266343e-02, -4.218805e-02, 4.741381e-01
-2738, 4.613917e-02, -3.835592e-02, 4.742869e-01
-2739, 3.993826e-02, -4.477651e-02, 4.673366e-01
-2740, 5.017357e-02, -3.290308e-02, 4.747061e-01
-2741, 5.251058e-02, -2.902825e-02, 4.758352e-01
-2742, 4.930702e-02, -3.418798e-02, 4.690961e-01
-2743, 1.554618e-02, 5.795098e-02, 2.939566e-02
-2744, 2.100717e-02, 5.620230e-02, 3.178082e-02
-2745, 9.774058e-03, 5.919855e-02, 3.171492e-02
-2746, -5.409402e-02, -2.595838e-02, 3.791651e-02
-2747, -5.703912e-02, -1.861554e-02, 3.559660e-02
-2748, 5.172122e-02, -3.041243e-02, 6.166952e-02
-2749, 5.253665e-02, -2.898104e-02, 5.603412e-02
-2750, 4.823159e-02, -3.568912e-02, 3.053047e-01
-2751, 4.861866e-02, -3.516000e-02, 2.985034e-01
-2752, 5.177136e-02, -3.032699e-02, 1.931204e-01
-2753, 5.259363e-02, -2.887750e-02, 1.851096e-01
-2754, 5.117969e-02, -3.131515e-02, 1.782978e-01
-2755, 4.956096e-02, -3.381879e-02, 3.852161e-01
-2756, 4.977104e-02, -3.350886e-02, 3.777629e-01
-2757, 4.914636e-02, -3.441853e-02, 2.434763e-01
-2758, 4.840730e-02, -3.545043e-02, 2.364087e-01
-2759, 5.118839e-02, -3.130094e-02, 2.909877e-01
-2760, 5.237662e-02, -2.926927e-02, 2.843505e-01
-2761, 5.046199e-02, -3.245901e-02, 2.782431e-01
-2762, 4.471755e-02, -4.000426e-02, 2.928485e-01
-2763, 5.238970e-02, -2.924585e-02, 2.577911e-01
-2764, 5.121993e-02, -3.124930e-02, 2.509514e-01
-2765, 5.046294e-02, -3.245754e-02, 2.636334e-01
-2766, 4.886844e-02, -3.481201e-02, 1.692244e-01
-2767, 4.812668e-02, -3.583047e-02, 1.618343e-01
-2768, 5.079542e-02, -3.193470e-02, 4.214187e-01
-2769, 5.066809e-02, -3.213634e-02, 4.119087e-01
-2770, 5.202220e-02, -2.989466e-02, 3.362783e-01
-2771, 5.093667e-02, -3.170892e-02, 3.294976e-01
-2772, 4.977152e-02, -3.350814e-02, 3.422054e-01
-2773, 5.014122e-02, -3.295236e-02, 4.028416e-01
-2774, 4.957527e-02, -3.379782e-02, 3.945050e-01
-2775, 4.412450e-02, -4.065745e-02, 3.894238e-01
-2776, 4.479380e-02, -3.991887e-02, 4.077799e-01
-2777, 5.105726e-02, -3.151437e-02, 3.697719e-01
-2778, 5.206389e-02, -2.982199e-02, 3.628463e-01
-2779, 4.982023e-02, -3.343568e-02, 3.568332e-01
-2780, 4.568139e-02, -3.890001e-02, 3.721439e-01
-2781, -3.617728e-02, 4.786653e-02, 2.899756e-02
-2782, -4.756396e-02, 3.657416e-02, 4.225732e-02
-2783, -4.253474e-02, 4.231780e-02, 4.280083e-02
-2784, 5.634949e-02, -2.060911e-02, 4.703869e-01
-2785, 5.453844e-02, -2.501116e-02, 4.637421e-01
-2786, 5.209184e-02, -2.977314e-02, 5.032577e-02
-2787, 4.863179e-02, -3.514184e-02, 2.094239e-01
-2788, 4.983974e-02, -3.340659e-02, 2.017570e-01
-2789, 5.240776e-02, -2.921348e-02, 1.012524e-01
-2790, 5.169985e-02, -3.044874e-02, 9.451381e-02
-2791, 5.012837e-02, -3.297190e-02, 1.068315e-01
-2792, 5.547757e-02, 2.285254e-02, 2.637490e-02
-2793, 5.284549e-02, 2.841397e-02, 4.731880e-01
-2794, 4.994824e-02, 3.324414e-02, 4.727859e-01
-2795, 4.846776e-02, 3.536774e-02, 4.663522e-01
-2796, 5.483253e-02, 2.435967e-02, 4.682951e-01
-2797, 4.768690e-02, -3.641373e-02, 2.267598e-01
-2798, 4.780046e-02, -3.626453e-02, 2.190662e-01
-2799, 4.185462e-02, -4.299059e-02, 2.315144e-01
-2800, 5.434120e-02, -2.543686e-02, 2.703476e-02
-2801, 5.415324e-02, 2.583460e-02, 4.452775e-02
-2802, 5.383069e-02, 2.650013e-02, 5.047731e-02
-2803, 5.325916e-02, 2.763082e-02, 5.684414e-02
-2804, 5.308441e-02, 2.796508e-02, 6.272567e-02
-2805, 5.050470e-02, 3.239251e-02, 5.300259e-02
-2806, 5.251769e-02, 2.901538e-02, 6.896783e-02
-2807, 5.254590e-02, 2.896426e-02, 7.462975e-02
-2808, 4.913430e-02, 3.443574e-02, 6.561159e-02
-2809, 5.318174e-02, 2.777954e-02, 8.042653e-02
-2810, 5.323688e-02, 2.767371e-02, 8.615857e-02
-2811, 4.922088e-02, 3.431188e-02, 7.765054e-02
-2812, 5.269031e-02, 2.870072e-02, 9.190828e-02
-2813, 5.279275e-02, 2.851185e-02, 9.726545e-02
-2814, 4.932426e-02, 3.416310e-02, 8.919703e-02
-2815, 5.378835e-02, 2.658595e-02, 1.023705e-01
-2816, 5.388739e-02, 2.638463e-02, 1.079922e-01
-2817, 4.988939e-02, 3.333239e-02, 1.000518e-01
-2818, 5.373810e-02, 2.668738e-02, 1.130486e-01
-2819, 5.350886e-02, 2.714409e-02, 1.186956e-01
-2820, 5.088298e-02, 3.179501e-02, 1.102133e-01
-2821, 5.224440e-02, 2.950462e-02, 1.238581e-01
-2822, 5.189955e-02, 3.010708e-02, 1.292671e-01
-2823, 4.922135e-02, 3.431120e-02, 1.204322e-01
-2824, 5.175972e-02, 3.034685e-02, 1.356637e-01
-2825, 5.191607e-02, 3.007859e-02, 1.411738e-01
-2826, 4.747213e-02, 3.669329e-02, 1.319913e-01
-2827, 5.284747e-02, 2.841029e-02, 1.468526e-01
-2828, 5.294957e-02, 2.821954e-02, 1.525735e-01
-2829, 4.845321e-02, 3.538766e-02, 1.440667e-01
-2830, 5.239688e-02, 2.923297e-02, 1.581667e-01
-2831, 5.247523e-02, 2.909210e-02, 1.636279e-01
-2832, 4.889547e-02, 3.477403e-02, 1.553388e-01
-2833, 5.321689e-02, 2.771213e-02, 1.691212e-01
-2834, 5.324516e-02, 2.765779e-02, 1.748011e-01
-2835, 4.913329e-02, 3.443719e-02, 1.664253e-01
-2836, 5.268215e-02, 2.871569e-02, 1.803174e-01
-2837, 5.256884e-02, 2.892260e-02, 1.858502e-01
-2838, 4.934373e-02, 3.413497e-02, 1.774350e-01
-2839, 5.260405e-02, 2.885851e-02, 1.918484e-01
-2840, 5.273560e-02, 2.861742e-02, 1.973812e-01
-2841, 4.869489e-02, 3.505435e-02, 1.889495e-01
-2842, 5.334443e-02, 2.746583e-02, 2.027717e-01
-2843, 5.334850e-02, 2.745793e-02, 2.084501e-01
-2844, 4.948581e-02, 3.392867e-02, 2.003382e-01
-2845, 5.261621e-02, 2.883633e-02, 2.138796e-01
-2846, 5.257028e-02, 2.891998e-02, 2.192786e-01
-2847, 4.933933e-02, 3.414134e-02, 2.111581e-01
-2848, 5.317237e-02, 2.779747e-02, 2.247469e-01
-2849, 5.311822e-02, 2.790080e-02, 2.304017e-01
-2850, 4.917541e-02, 3.437702e-02, 2.220558e-01
-2851, 5.234276e-02, 2.932977e-02, 2.359103e-01
-2852, 5.224641e-02, 2.950105e-02, 2.413621e-01
-2853, 4.897285e-02, 3.466497e-02, 2.330326e-01
-2854, 5.257306e-02, 2.891494e-02, 2.474268e-01
-2855, 5.279316e-02, 2.851110e-02, 2.528781e-01
-2856, 4.841499e-02, 3.543993e-02, 2.446059e-01
-2857, 5.371487e-02, 2.673412e-02, 2.581408e-01
-2858, 5.378802e-02, 2.658662e-02, 2.638234e-01
-2859, 4.994522e-02, 3.324868e-02, 2.559332e-01
-2860, 5.319119e-02, 2.776143e-02, 2.692607e-01
-2861, 5.315150e-02, 2.783735e-02, 2.746970e-01
-2862, 5.032108e-02, 3.267703e-02, 2.666333e-01
-2863, 5.360187e-02, 2.695997e-02, 2.800987e-01
-2864, 5.358632e-02, 2.699086e-02, 2.856656e-01
-2865, 5.013977e-02, 3.295457e-02, 2.774723e-01
-2866, 5.306498e-02, 2.800192e-02, 2.910432e-01
-2867, 5.309369e-02, 2.794745e-02, 2.964289e-01
-2868, 5.005648e-02, 3.308094e-02, 2.882515e-01
-2869, 5.374675e-02, 2.666996e-02, 3.018414e-01
-2870, 5.371276e-02, 2.673835e-02, 3.074948e-01
-2871, 5.021973e-02, 3.283259e-02, 2.990416e-01
-2872, 5.288419e-02, 2.834189e-02, 3.127269e-01
-2873, 5.283752e-02, 2.842880e-02, 3.181520e-01
-2874, 5.001617e-02, 3.314186e-02, 3.096862e-01
-2875, 5.319441e-02, 2.775527e-02, 3.236972e-01
-2876, 5.308970e-02, 2.795502e-02, 3.293517e-01
-2877, 4.943265e-02, 3.400607e-02, 3.204635e-01
-2878, 5.237359e-02, 2.927468e-02, 3.347383e-01
-2879, 5.213865e-02, 2.969109e-02, 3.403269e-01
-2880, 4.900993e-02, 3.461252e-02, 3.313954e-01
-2881, 5.194427e-02, 3.002986e-02, 3.466726e-01
-2882, 5.196017e-02, 3.000235e-02, 3.523226e-01
-2883, 4.789427e-02, 3.614055e-02, 3.431277e-01
-2884, 5.216819e-02, 2.963917e-02, 3.585795e-01
-2885, 5.245764e-02, 2.912380e-02, 3.641029e-01
-2886, 4.791111e-02, 3.611822e-02, 3.557303e-01
-2887, 5.343364e-02, 2.729187e-02, 3.695381e-01
-2888, 5.351141e-02, 2.713907e-02, 3.752521e-01
-2889, 4.937080e-02, 3.409581e-02, 3.674225e-01
-2890, 5.307073e-02, 2.799103e-02, 3.806705e-01
-2891, 5.313312e-02, 2.787241e-02, 3.861107e-01
-2892, 4.999674e-02, 3.317116e-02, 3.782761e-01
-2893, 5.380527e-02, 2.655171e-02, 3.914153e-01
-2894, 5.381170e-02, 2.653867e-02, 3.970926e-01
-2895, 5.028384e-02, 3.273431e-02, 3.889992e-01
-2896, 5.315571e-02, 2.782932e-02, 4.025005e-01
-2897, 5.312362e-02, 2.789052e-02, 4.079754e-01
-2898, 5.030244e-02, 3.270572e-02, 3.997117e-01
-2899, 5.368134e-02, 2.680138e-02, 4.135793e-01
-2900, 5.360114e-02, 2.696142e-02, 4.194032e-01
-2901, 5.017990e-02, 3.289343e-02, 4.107235e-01
-2902, 5.285317e-02, 2.839969e-02, 4.250657e-01
-2903, 5.274870e-02, 2.859327e-02, 4.308250e-01
-2904, 4.996086e-02, 3.322517e-02, 4.219899e-01
-2905, 5.292135e-02, 2.827244e-02, 4.375793e-01
-2906, 5.300925e-02, 2.810728e-02, 4.435705e-01
-2907, 4.925397e-02, 3.426437e-02, 4.344066e-01
-2908, 5.352732e-02, 2.710768e-02, 4.501761e-01
-2909, 5.386253e-02, 2.643534e-02, 4.562065e-01
-2910, 5.008971e-02, 3.303060e-02, 4.477665e-01
-2911, 5.492936e-02, 2.414054e-02, 3.260415e-02
-2912, 5.460604e-02, 2.486322e-02, 3.829302e-02
-2913, 5.172862e-02, 3.039983e-02, 4.040103e-02
-2914, 5.293665e-02, 2.824378e-02, 2.793706e-02
-2915, 4.981258e-02, 3.344707e-02, 2.884359e-02
-2916, 5.757084e-02, -1.689966e-02, 4.758833e-01
-2917, 5.458661e-02, -2.490587e-02, 4.750117e-01
-2918, -3.440855e-02, 4.915335e-02, 4.050471e-02
-2919, -2.876493e-02, 5.265528e-02, 3.655910e-02
-2920, -3.586751e-02, 4.809908e-02, 5.036237e-02
-2921, 5.149580e-02, -3.079257e-02, 1.287228e-01
-2922, 4.938968e-02, -3.406846e-02, 1.223283e-01
-2923, -9.201520e-05, 5.999993e-02, 3.469427e-02
-2924, 5.053945e-03, 5.978677e-02, 4.128031e-02
-2925, 4.543631e-02, -3.918599e-02, 1.939442e-01
-2926, 4.528177e-02, -3.936446e-02, 2.486384e-01
-2927, 4.507078e-02, -3.960587e-02, 1.762343e-01
-2928, 5.320106e-02, -2.774252e-02, 3.438020e-02
-2929, 5.090190e-02, -3.176470e-02, 2.928209e-02
-2930, 4.707891e-02, -3.719645e-02, 2.911825e-02
-2931, 5.270955e-02, -2.866538e-02, 4.055591e-02
-2932, 5.220264e-02, -2.957844e-02, 4.558028e-01
-2933, 5.130994e-02, -3.110128e-02, 4.483051e-01
-2934, 4.939450e-02, -3.406147e-02, 3.214019e-01
-2935, 4.901529e-02, -3.460493e-02, 3.144756e-01
-2936, 4.528063e-02, -3.936578e-02, 3.268016e-01
-2937, 4.566438e-02, 3.891997e-02, 3.029844e-02
-2938, 4.855344e-02, 3.525002e-02, 3.562115e-02
-2939, 4.110797e-02, 4.370509e-02, 3.129424e-02
-2940, 5.076439e-02, -3.198400e-02, 4.392372e-01
-2941, 5.100090e-02, -3.160550e-02, 4.307456e-01
-2942, 5.023127e-02, -3.281493e-02, 4.615760e-01
-2943, 4.876572e-02, -3.495576e-02, 4.639740e-02
-2944, 4.199348e-02, -4.285496e-02, 2.122231e-01
-2945, -6.117124e-03, 5.968736e-02, 3.452728e-02
-2946, 4.738164e-02, -3.681006e-02, 8.846708e-02
-2947, 5.141371e-02, -3.092944e-02, 8.450978e-02
-2948, 4.568666e-02, -3.889382e-02, 4.261740e-01
-2949, -3.459108e-02, -4.902507e-02, 3.354321e-02
-2950, -3.919088e-02, -4.543210e-02, 3.510822e-02
-2951, 2.517199e-02, -5.446440e-02, 3.660767e-02
-2952, 1.927495e-02, -5.681968e-02, 3.704668e-02
-2953, -2.960291e-02, -5.218877e-02, 3.453448e-02
-2954, -5.893750e-02, -1.124148e-02, 3.272867e-02
-2955, -5.993603e-02, -2.769965e-03, 3.475912e-02
-2956, -5.817848e-02, -1.467190e-02, 4.502926e-02
-2957, -1.844488e-03, -5.997164e-02, 3.372742e-02
-2958, -8.661369e-03, -5.937155e-02, 3.257804e-02
-2959, 4.245101e-02, -4.240179e-02, 3.095351e-01
-2960, 5.130981e-02, -3.110150e-02, 7.281742e-02
-2961, 4.753041e-02, -3.661776e-02, 6.731516e-02
-2962, -4.550988e-02, -3.910052e-02, 3.763161e-02
-2963, -4.982801e-02, -3.342408e-02, 3.769179e-02
-2964, -4.136459e-02, -4.346229e-02, 4.492437e-02
-2965, 1.159870e-02, -5.886824e-02, 3.682757e-02
-2966, 5.161539e-03, -5.977758e-02, 3.616088e-02
-2967, 1.636181e-02, -5.772600e-02, 4.597754e-02
-2968, -1.511407e-02, -5.806518e-02, 3.629928e-01
-2969, -1.231849e-02, -5.872184e-02, 4.260285e-02
-2970, -1.551567e-02, -5.795916e-02, 3.428936e-02
-2971, 4.659790e-02, -3.779730e-02, 4.445688e-01
-2972, 2.285322e-02, 5.547730e-02, 4.113234e-02
-2973, 2.871064e-02, 5.268490e-02, 3.461221e-02
-2974, 5.446434e-02, 2.517212e-02, 4.626036e-01
-2975, -5.978567e-02, 5.066882e-03, 3.801562e-02
-2976, -5.853914e-02, 1.315938e-02, 3.805958e-02
-2977, -5.999657e-02, 6.412869e-04, 4.541783e-02
-2978, -5.606804e-02, 2.136294e-02, 3.928369e-02
-2979, -5.286289e-02, 2.838159e-02, 4.148934e-02
-2980, -2.180829e-02, -5.589632e-02, 3.549107e-02
-2981, -2.703749e-02, -5.356281e-02, 4.335758e-02
-2982, -2.110877e-02, 5.616422e-02, 1.570838e-01
-2983, 5.143508e-02, 3.089389e-02, 4.607692e-01
-2984, 1.661393e-02, 5.765394e-02, 1.033857e-01
-2985, 2.850844e-02, 5.279459e-02, 1.119779e-01
-2986, 2.825503e-02, 5.293065e-02, 9.974431e-02
-2987, -5.759090e-02, 1.683118e-02, 4.989843e-02
-2988, -4.985491e-02, 3.338394e-02, 5.189052e-02
-2989, -5.214462e-02, -2.968061e-02, 4.767248e-02
-2990, -3.884021e-02, 4.573224e-02, 6.251990e-02
-2991, -3.016997e-02, 5.186302e-02, 6.022378e-02
-2992, 3.373927e-02, -4.961514e-02, 2.372275e-01
-2993, 3.273785e-02, -5.028154e-02, 2.275786e-01
-2994, -1.185545e-02, 5.881707e-02, 3.628116e-02
-2995, -2.282517e-02, 5.548884e-02, 3.818445e-02
-2996, -1.613000e-02, 5.779120e-02, 4.616295e-02
-2997, 3.080542e-02, 5.148812e-02, 4.568520e-01
-2998, 2.487657e-02, 5.459997e-02, 4.554997e-01
-2999, -3.673366e-02, 4.744089e-02, 4.546874e-01
-3000, -4.168589e-02, 4.315422e-02, 4.548196e-01
-3001, -5.737816e-02, 1.754271e-02, 4.558198e-01
-3002, -5.901473e-02, 1.082875e-02, 4.552522e-01
-3003, -5.599801e-02, -2.154583e-02, 4.557326e-01
-3004, -5.378984e-02, -2.658294e-02, 4.547894e-01
-3005, 4.620645e-02, -3.827485e-02, 4.611568e-01
-3006, 3.537143e-02, -4.846506e-02, 1.928336e-01
-3007, 3.824154e-02, -4.623402e-02, 1.841970e-01
-3008, 4.182791e-02, -4.301658e-02, 1.569754e-01
-3009, 4.781737e-02, -3.624223e-02, 1.516488e-01
-3010, 5.029990e-02, -3.270963e-02, 1.355924e-01
-3011, 5.199204e-02, -2.994709e-02, 7.855099e-02
-3012, 4.837688e-02, -3.549194e-02, 1.442550e-01
-3013, 3.265830e-02, -5.033325e-02, 2.152395e-01
-3014, 3.382127e-02, -4.955927e-02, 2.055972e-01
-3015, 2.340600e-02, -5.524635e-02, 2.209527e-01
-3016, 4.383530e-02, -4.096909e-02, 1.381273e-01
-3017, 4.591327e-02, -3.862605e-02, 3.493650e-01
-3018, 4.283923e-02, -4.200953e-02, 3.420568e-01
-3019, 4.290032e-02, -4.194714e-02, 3.566846e-01
-3020, 1.608085e-03, -5.997845e-02, 4.332498e-02
-3021, 4.421061e-02, -4.056381e-02, 3.839099e-02
-3022, 4.135709e-02, -4.346943e-02, 3.088170e-02
-3023, 4.044671e-02, -4.431776e-02, 7.277621e-02
-3024, 4.103585e-02, -4.377281e-02, 6.162831e-02
-3025, 3.938634e-02, -4.526274e-02, 3.336406e-01
-3026, 3.722160e-02, -4.705903e-02, 3.255450e-01
-3027, 3.492025e-02, -4.879115e-02, 1.751236e-01
-3028, -4.950226e-02, -3.390466e-02, 5.972099e-02
-3029, -5.384031e-02, -2.648059e-02, 5.994570e-02
-3030, 4.795689e-02, -3.605741e-02, 2.704972e-01
-3031, 4.488634e-02, -3.981478e-02, 2.629772e-01
-3032, 4.488518e-02, -3.981609e-02, 2.775869e-01
-3033, 3.247678e-02, -5.045055e-02, 3.358656e-02
-3034, 3.124527e-02, -5.122239e-02, 4.317555e-02
-3035, 3.929966e-02, -4.533803e-02, 9.701557e-02
-3036, 3.887524e-02, -4.570247e-02, 8.701155e-02
-3037, 3.420648e-02, 4.929418e-02, 3.473811e-02
-3038, 3.773520e-02, 4.664820e-02, 4.051987e-02
-3039, 2.252577e-02, 5.561106e-02, 3.944690e-01
-3040, 1.163081e-02, 5.886191e-02, 3.856761e-01
-3041, 1.048409e-02, 5.907693e-02, 3.951377e-01
-3042, 3.908521e-02, -4.552303e-02, 4.315904e-01
-3043, 3.878996e-02, -4.577487e-02, 4.222634e-01
-3044, 4.762983e-02, 3.648835e-02, 4.599551e-01
-3045, -1.800489e-02, 5.723482e-02, 6.052103e-02
-3046, -6.791092e-03, 5.961444e-02, 5.861774e-02
-3047, -2.159169e-02, 5.598034e-02, 7.267856e-02
-3048, -5.894859e-02, 1.118319e-02, 6.029764e-02
-3049, -5.675478e-02, 1.946521e-02, 6.152175e-02
-3050, 3.682428e-02, -4.737059e-02, 3.138985e-02
-3051, 3.311075e-02, -5.003677e-02, 1.609892e-01
-3052, 3.268005e-02, -5.031913e-02, 1.508037e-01
-3053, 4.334329e-02, -4.148927e-02, 4.816085e-02
-3054, 3.479329e-02, -4.888177e-02, 3.159855e-01
-3055, 3.369482e-02, -4.964533e-02, 3.068146e-01
-3056, 2.768109e-02, -5.323304e-02, 3.228245e-01
-3057, 1.555663e-02, 5.794818e-02, 5.120745e-02
-3058, 2.356019e-02, 5.518077e-02, 5.403885e-02
-3059, 5.817439e-03, 5.971731e-02, 5.418681e-02
-3060, 4.791608e-02, 3.611163e-02, 4.185588e-02
-3061, 4.388112e-02, 4.092002e-02, 6.175176e-02
-3062, 4.305854e-02, 4.178471e-02, 6.799393e-02
-3063, 4.408381e-02, 4.070157e-02, 1.016416e-01
-3064, 4.552548e-02, 3.908235e-02, 1.067467e-01
-3065, 4.119231e-02, 4.362561e-02, 1.276738e-01
-3066, 4.099005e-02, 4.381570e-02, 1.340704e-01
-3067, 4.205443e-02, 4.279515e-02, 1.445572e-01
-3068, 4.339574e-02, 4.143441e-02, 1.502360e-01
-3069, 3.489209e-02, 4.881129e-02, 1.402397e-01
-3070, 4.398532e-02, 4.080799e-02, 1.716791e-01
-3071, 4.316152e-02, 4.167833e-02, 1.771954e-01
-3072, 4.424335e-02, 4.052809e-02, 2.061554e-01
-3073, 4.317417e-02, 4.166523e-02, 2.115848e-01
-3074, 4.291449e-02, 4.193264e-02, 2.216613e-01
-3075, 4.379499e-02, 4.101218e-02, 2.271296e-01
-3076, 3.681955e-02, 4.737426e-02, 2.166586e-01
-3077, 4.493428e-02, 3.976067e-02, 2.567817e-01
-3078, 4.623564e-02, 3.823959e-02, 2.620444e-01
-3079, 4.448334e-02, 4.026453e-02, 2.827982e-01
-3080, 4.371200e-02, 4.110062e-02, 2.881757e-01
-3081, 4.516053e-02, 3.950350e-02, 2.985497e-01
-3082, 4.609216e-02, 3.841240e-02, 3.039622e-01
-3083, 3.867316e-02, 4.587359e-02, 2.930964e-01
-3084, 4.320607e-02, 4.163215e-02, 3.244307e-01
-3085, 4.215082e-02, 4.270022e-02, 3.298173e-01
-3086, 4.376786e-02, 4.104113e-02, 3.684467e-01
-3087, 4.516128e-02, 3.950265e-02, 3.738819e-01
-3088, 4.452402e-02, 4.021954e-02, 3.793004e-01
-3089, -1.033391e-02, 5.910339e-02, 2.169520e-01
-3090, -2.299637e-02, 5.541811e-02, 2.231107e-01
-3091, 4.573152e-02, 3.884106e-02, 4.156394e-01
-3092, 4.466548e-02, 4.006239e-02, 4.213019e-01
-3093, 4.433482e-02, 4.042801e-02, 4.306193e-01
-3094, 4.457949e-02, 4.015805e-02, 4.373736e-01
-3095, 3.930158e-02, 4.533636e-02, 4.242688e-01
-3096, 4.566158e-02, 3.892326e-02, 4.462145e-01
-3097, 4.638389e-02, 3.805962e-02, 4.528201e-01
-3098, 4.279627e-02, 4.205329e-02, 4.584030e-01
-3099, 4.016246e-02, 4.457552e-02, 4.424271e-01
-3100, 3.547700e-02, -4.838783e-02, 5.362190e-02
-3101, 4.354809e-02, 4.127425e-02, 4.391247e-02
-3102, 4.732801e-02, 3.687898e-02, 4.869235e-02
-3103, 4.653879e-02, 3.787005e-02, 5.505918e-02
-3104, 3.697869e-02, 4.725015e-02, 4.735634e-02
-3105, 1.729995e-02, 5.745182e-02, 4.547848e-01
-3106, 1.082473e-02, 5.901547e-02, 4.550418e-01
-3107, 2.125388e-02, 5.610947e-02, 4.466530e-01
-3108, 2.852884e-03, 5.993214e-02, 4.570799e-01
-3109, -2.577200e-03, 5.994462e-02, 4.585264e-01
-3110, 5.585326e-03, 5.973947e-02, 4.479762e-01
-3111, -7.729511e-03, 5.950004e-02, 4.573669e-01
-3112, -1.395065e-02, -5.835563e-02, 4.258736e-01
-3113, -2.244905e-02, -5.564207e-02, 4.183376e-01
-3114, -1.307922e-02, -5.855710e-02, 4.143964e-01
-3115, -1.478386e-02, 5.815013e-02, 4.571846e-01
-3116, -2.015379e-02, 5.651393e-02, 4.564318e-01
-3117, -9.582371e-03, 5.922988e-02, 4.498321e-01
-3118, -2.593274e-02, 5.410631e-02, 4.537779e-01
-3119, -3.099345e-02, 5.137515e-02, 4.535647e-01
-3120, -2.250897e-02, 5.561786e-02, 4.469960e-01
-3121, -4.675638e-02, 3.760108e-02, 4.532004e-01
-3122, -5.063606e-02, 3.218680e-02, 4.542086e-01
-3123, -4.493622e-02, 3.975847e-02, 4.449683e-01
-3124, -3.573277e-02, -4.819927e-02, 1.863807e-01
-3125, -3.692066e-02, -4.729551e-02, 1.711611e-01
-3126, -3.959041e-02, 4.508436e-02, 1.200586e-01
-3127, -5.500616e-02, 2.396504e-02, 4.554698e-01
-3128, -5.419305e-02, 2.575098e-02, 4.446103e-01
-3129, -5.754228e-02, -1.699664e-02, 3.861859e-01
-3130, -3.729497e-02, -4.700091e-02, 1.563492e-01
-3131, -3.741374e-02, -4.690642e-02, 1.408459e-01
-3132, -5.999597e-02, 6.956859e-04, 4.535323e-01
-3133, -5.967394e-02, -6.246655e-03, 4.522703e-01
-3134, -5.958015e-02, 7.085609e-03, 4.441516e-01
-3135, -5.780649e-02, -1.607512e-02, 4.538459e-01
-3136, -5.857419e-02, -1.300248e-02, 4.440073e-01
-3137, -4.931024e-02, -3.418333e-02, 4.570231e-01
-3138, -4.634502e-02, -3.810694e-02, 4.584484e-01
-3139, -5.169108e-02, -3.046361e-02, 4.478167e-01
-3140, -4.307067e-02, -4.177220e-02, 4.568135e-01
-3141, -2.668173e-02, -5.374091e-02, 3.247520e-01
-3142, -2.845909e-02, -5.282121e-02, 3.114142e-01
-3143, -3.714961e-02, -4.711588e-02, 4.539913e-01
-3144, -3.245529e-02, -5.046439e-02, 4.540246e-01
-3145, -4.125051e-02, -4.357058e-02, 4.472281e-01
-3146, -2.527456e-02, -5.441688e-02, 4.572446e-01
-3147, -2.045874e-02, -5.640425e-02, 4.586595e-01
-3148, -2.814786e-02, -5.298771e-02, 4.476260e-01
-3149, -1.513857e-02, -5.805879e-02, 4.570910e-01
-3150, -3.028818e-02, -5.179408e-02, 2.843082e-01
-3151, -2.932321e-02, -5.234644e-02, 2.976652e-01
-3152, -7.458271e-03, -5.953465e-02, 4.534583e-01
-3153, -3.590556e-04, -5.999893e-02, 4.535352e-01
-3154, -1.316110e-02, -5.853875e-02, 4.472134e-01
-3155, -1.762904e-02, -5.735169e-02, 3.041241e-01
-3156, 4.105741e-03, -5.985936e-02, 4.419509e-01
-3157, 9.156603e-03, -5.929719e-02, 4.519054e-01
-3158, 1.706843e-02, -5.752103e-02, 4.508295e-01
-3159, -2.365072e-02, 5.514203e-02, 2.380906e-01
-3160, 2.698895e-02, -5.358728e-02, 4.539777e-01
-3161, 3.360945e-02, -4.970317e-02, 4.563070e-01
-3162, 2.368398e-02, -5.512775e-02, 4.434694e-01
-3163, 4.115814e-02, -4.365784e-02, 4.598166e-01
-3164, 2.505501e-02, -5.451831e-02, 1.958500e-01
-3165, 3.583372e-02, -4.812426e-02, 3.927477e-01
-3166, 3.581335e-02, -4.813942e-02, 3.834588e-01
-3167, -3.722665e-02, -4.705503e-02, 5.282194e-02
-3168, -4.380878e-02, -4.099745e-02, 5.534532e-02
-3169, -4.620241e-02, -3.827973e-02, 6.761855e-02
-3170, -5.248058e-02, 2.908244e-02, 1.084988e-01
-3171, -5.760476e-02, 1.678369e-02, 1.084583e-01
-3172, 3.433349e-02, -4.920581e-02, 3.408002e-01
-3173, 3.103459e-02, -5.135031e-02, 8.132470e-02
-3174, 2.842911e-02, -5.283735e-02, 5.664301e-02
-3175, 3.995175e-02, 4.476447e-02, 5.744152e-02
-3176, 2.478267e-02, -5.464265e-02, 1.689519e-01
-3177, 3.992010e-02, -4.479270e-02, 4.410593e-01
-3178, 3.214477e-02, -5.066274e-02, 4.371487e-01
-3179, 3.758579e-02, -4.676867e-02, 4.119800e-01
-3180, 3.682375e-02, -4.737100e-02, 4.029128e-01
-3181, 2.739358e-02, -5.338157e-02, 3.969478e-01
-3182, 2.985867e-02, -5.204287e-02, 4.173964e-01
-3183, 4.680278e-02, -3.754330e-02, 1.142550e-01
-3184, 4.408837e-02, -4.069662e-02, 1.058947e-01
-3185, 4.068879e-02, -4.409560e-02, 4.501272e-01
-3186, 3.876505e-02, -4.579597e-02, 2.565315e-01
-3187, 3.579854e-02, -4.815044e-02, 2.490564e-01
-3188, 3.730499e-02, 4.699296e-02, 4.588020e-01
-3189, 3.529659e-02, 4.851959e-02, 4.493179e-01
-3190, 4.318093e-02, -4.165822e-02, 1.213915e-01
-3191, 2.579725e-02, -5.417104e-02, 2.451206e-01
-3192, -2.548389e-02, -5.431916e-02, 1.318472e-01
-3193, -3.717869e-02, -4.709294e-02, 1.237519e-01
-3194, 4.335309e-02, 4.147903e-02, 2.007649e-01
-3195, 2.313285e-02, -5.536128e-02, 3.041457e-01
-3196, 3.203308e-02, -5.073344e-02, 2.976953e-01
-3197, 4.307001e-02, 4.177289e-02, 7.796709e-02
-3198, 4.399524e-02, 4.079729e-02, 8.376387e-02
-3199, 3.685745e-02, 4.734478e-02, 7.410727e-02
-3200, 4.319595e-02, 4.164265e-02, 8.951359e-02
-3201, -2.415313e-02, 5.492382e-02, 3.203474e-01
-3202, -2.459267e-02, 5.472842e-02, 3.379515e-01
-3203, 4.530489e-02, 3.933786e-02, 1.118031e-01
-3204, -4.170728e-02, -4.313355e-02, 4.096966e-01
-3205, -4.964997e-02, -3.368799e-02, 4.093474e-01
-3206, 4.350451e-02, 4.132018e-02, 1.169656e-01
-3207, -3.741388e-02, -4.690631e-02, 1.086907e-01
-3208, -4.729353e-02, -3.692318e-02, 1.176894e-01
-3209, -3.228081e-02, -5.057618e-02, 2.432327e-01
-3210, -3.314417e-02, -5.001464e-02, 2.292758e-01
-3211, 4.290489e-02, 4.194247e-02, 1.661858e-01
-3212, 4.259059e-02, 4.226159e-02, 1.558293e-01
-3213, -5.872583e-02, -1.229948e-02, 1.321015e-01
-3214, -5.993321e-02, -2.830148e-03, 1.183225e-01
-3215, 3.643794e-02, 4.766840e-02, 1.610830e-01
-3216, 4.361115e-02, 4.120762e-02, 1.860477e-01
-3217, 4.366134e-02, 4.115444e-02, 1.920459e-01
-3218, 3.746384e-02, 4.686642e-02, 1.978631e-01
-3219, 3.730481e-02, 4.699310e-02, 1.802918e-01
-3220, 4.260665e-02, 4.224539e-02, 2.483891e-01
-3221, 3.800530e-02, 4.642841e-02, 2.545002e-01
-3222, 4.213156e-02, 4.271922e-02, 2.423244e-01
-3223, 4.266771e-02, 4.218373e-02, 2.326382e-01
-3224, -1.912189e-02, -5.687138e-02, 2.768320e-01
-3225, -3.078940e-02, -5.149770e-02, 2.707652e-01
-3226, 4.538472e-02, 3.924573e-02, 2.674818e-01
-3227, -3.136739e-02, -5.114770e-02, 2.571169e-01
-3228, 4.381553e-02, 4.099023e-02, 2.773965e-01
-3229, 3.881846e-02, 4.575071e-02, 2.728076e-01
-3230, 4.491590e-02, 3.978143e-02, 3.091943e-01
-3231, -1.398123e-04, 5.999984e-02, 3.989879e-01
-3232, -1.172578e-02, 5.884306e-02, 3.956895e-01
-3233, -1.102994e-02, 5.897746e-02, 4.083326e-01
-3234, 4.267370e-02, 4.217766e-02, 3.188855e-01
-3235, 3.780566e-02, 4.659112e-02, 3.131615e-01
-3236, 4.261434e-02, 4.223764e-02, 3.389402e-01
-3237, 4.233849e-02, 4.251414e-02, 3.452859e-01
-3238, 3.572999e-02, 4.820133e-02, 3.319756e-01
-3239, 4.130387e-02, 4.352000e-02, 3.533416e-01
-3240, 4.160645e-02, 4.323082e-02, 3.595986e-01
-3241, 3.509375e-02, 4.866650e-02, 3.491542e-01
-3242, 4.506180e-02, 3.961609e-02, 3.892687e-01
-3243, 4.602643e-02, 3.849114e-02, 3.945733e-01
-3244, 3.941596e-02, 4.523695e-02, 3.848745e-01
-3245, 4.508431e-02, 3.959047e-02, 3.999812e-01
-3246, 4.492993e-02, 3.976558e-02, 4.100355e-01
-3247, 3.984757e-02, 4.485724e-02, 4.048971e-01
-3248, 3.868117e-03, 5.987518e-02, 6.854489e-02
-3249, -5.229489e-02, 2.941505e-02, 6.238671e-02
-3250, -4.683597e-02, 3.750189e-02, 6.315468e-02
-3251, -4.227150e-02, 4.258075e-02, 7.301609e-02
-3252, -5.489428e-02, 2.422021e-02, 7.278591e-02
-3253, 3.592044e-02, 4.805957e-02, 2.364213e-01
-3254, -2.956505e-02, -5.221023e-02, 5.373544e-02
-3255, -3.253488e-02, -5.041311e-02, 6.415639e-02
-3256, 3.788250e-02, 4.652866e-02, 9.620846e-02
-3257, 3.531582e-02, -4.850560e-02, 2.633953e-01
-3258, 3.633329e-02, 4.774822e-02, 1.190447e-01
-3259, -4.793693e-02, 3.608394e-02, 4.116837e-01
-3260, -5.423874e-02, 2.565462e-02, 4.109340e-01
-3261, -5.363873e-02, -2.688655e-02, 1.243210e-01
-3262, 3.640600e-02, 4.769280e-02, 3.660580e-01
-3263, -6.630167e-03, 5.963255e-02, 4.300517e-01
-3264, -7.770444e-03, 5.949471e-02, 4.201600e-01
-3265, -3.006645e-02, 5.192310e-02, 4.151596e-01
-3266, -3.985243e-02, 4.485292e-02, 4.131533e-01
-3267, -1.066685e-02, 5.904421e-02, 1.626818e-01
-3268, -1.677649e-02, 5.760685e-02, 1.107353e-01
-3269, -4.478931e-03, 5.983259e-02, 1.139610e-01
-3270, -5.957034e-02, 7.167580e-03, 3.876958e-01
-3271, -5.986538e-02, -4.017046e-03, 3.879397e-01
-3272, 1.226923e-02, -5.873215e-02, 2.013052e-01
-3273, 1.412021e-02, -5.831483e-02, 1.885415e-01
-3274, -5.826431e-02, -1.432723e-02, 3.973625e-01
-3275, 2.424599e-02, -5.488289e-02, 1.409425e-01
-3276, 3.401745e-02, -4.942482e-02, 1.369287e-01
-3277, -3.769950e-02, -4.667705e-02, 7.439921e-02
-3278, -4.432166e-02, -4.044243e-02, 7.877487e-02
-3279, -3.009030e-02, -5.190928e-02, 7.531271e-02
-3280, 1.596000e-02, -5.783838e-02, 2.527250e-01
-3281, 1.351038e-02, -5.845913e-02, 2.408961e-01
-3282, -2.270173e-02, 5.553946e-02, 3.520759e-01
-3283, -1.842402e-02, 5.710127e-02, 3.680582e-01
-3284, 1.216999e-02, -5.875280e-02, 2.273145e-01
-3285, 1.207706e-02, -5.877197e-02, 2.149755e-01
-3286, 5.669906e-04, -5.999732e-02, 2.076670e-01
-3287, 1.742719e-03, -5.997469e-02, 2.349189e-01
-3288, 3.485832e-02, -4.883541e-02, 1.044391e-01
-3289, 3.764707e-02, -4.671935e-02, 3.734464e-01
-3290, 3.946521e-02, -4.519400e-02, 3.654555e-01
-3291, 1.930597e-02, -5.680915e-02, 3.299438e-01
-3292, 1.640735e-02, -5.771307e-02, 3.203843e-01
-3293, 1.868857e-03, -5.997089e-02, 5.412750e-02
-3294, -5.137248e-03, -5.977967e-02, 5.169404e-02
-3295, 3.641721e-02, -4.768424e-02, 2.904107e-01
-3296, 3.999042e-02, -4.472993e-02, 2.828950e-01
-3297, 3.661717e-02, -4.753086e-02, 2.751491e-01
-3298, 2.619126e-02, -5.398164e-02, 2.877418e-01
-3299, -5.666671e-02, -1.972014e-02, 6.949743e-02
-3300, -5.810749e-02, -1.495057e-02, 5.744892e-02
-3301, -3.412549e-02, 4.935029e-02, 4.454649e-01
-3302, 3.674838e-02, -4.742949e-02, 1.282661e-01
-3303, 3.323039e-02, -4.995739e-02, 1.201929e-01
-3304, -2.895993e-02, 5.254829e-02, 8.230784e-02
-3305, -1.667362e-02, 5.763671e-02, 8.260510e-02
-3306, -5.999896e-02, 3.537305e-04, 5.783749e-02
-3307, -5.991903e-02, 3.116128e-03, 6.946080e-02
-3308, 3.395581e-02, 4.946719e-02, 4.404771e-01
-3309, 2.834591e-02, -5.288203e-02, 3.767703e-01
-3310, 1.438642e-02, -5.824973e-02, 3.085182e-01
-3311, 1.245045e-02, -5.869401e-02, 2.993989e-01
-3312, 5.405203e-03, -5.975604e-02, 3.156375e-01
-3313, 2.707320e-02, 5.354477e-02, 6.412403e-02
-3314, 3.371066e-02, 4.963458e-02, 5.404892e-02
-3315, 1.921621e-02, -5.683958e-02, 5.409018e-02
-3316, 1.153784e-02, -5.888020e-02, 5.387107e-02
-3317, -1.206305e-02, -5.877485e-02, 5.340537e-02
-3318, 2.948221e-02, -5.225705e-02, 2.687033e-01
-3319, 1.348259e-02, -5.846554e-02, 1.744283e-01
-3320, 1.133331e-02, -5.891991e-02, 1.602940e-01
-3321, 1.080505e-04, -5.999990e-02, 1.798836e-01
-3322, 2.748101e-02, -5.333661e-02, 1.113138e-01
-3323, -1.485665e-02, -5.813157e-02, 6.378323e-02
-3324, -2.176775e-02, -5.591212e-02, 5.469203e-02
-3325, -5.463741e-02, -2.479423e-02, 8.107421e-02
-3326, -5.854413e-02, -1.313714e-02, 7.857743e-02
-3327, 1.168191e-02, -5.885179e-02, 1.457278e-01
-3328, 1.325563e-02, -5.851742e-02, 1.318528e-01
-3329, -1.919550e-04, -5.999969e-02, 1.512042e-01
-3330, -5.953309e-02, -7.470702e-03, 5.458098e-02
-3331, 1.539817e-02, -5.799048e-02, 1.176019e-01
-3332, 1.730045e-02, -5.745167e-02, 1.018481e-01
-3333, 2.369126e-03, -5.995321e-02, 1.223871e-01
-3334, -5.992993e-02, -2.898803e-03, 8.038255e-02
-3335, -5.946808e-02, 7.971666e-03, 8.284270e-02
-3336, -5.941760e-02, -8.339573e-03, 9.195933e-02
-3337, 2.396769e-02, -5.500500e-02, 6.453654e-02
-3338, -8.979813e-03, -5.932422e-02, 7.506789e-02
-3339, -1.882067e-02, -5.697177e-02, 7.635456e-02
-3340, 3.889679e-03, 5.987379e-02, 8.206397e-02
-3341, 1.631657e-02, 5.773881e-02, 7.763304e-02
-3342, 1.699169e-02, -5.754374e-02, 3.790686e-01
-3343, 1.920293e-02, -5.684406e-02, 3.690563e-01
-3344, 1.548284e-02, -5.796794e-02, 3.922020e-01
-3345, 5.675528e-03, -5.973097e-02, 3.844879e-01
-3346, 2.375956e-02, -5.509522e-02, 3.409670e-01
-3347, 1.219138e-02, -5.874836e-02, 3.385268e-01
-3348, 4.853025e-03, -5.980341e-02, 6.224014e-02
-3349, -2.475848e-02, -5.465361e-02, 8.659738e-02
-3350, 2.603962e-02, 5.405496e-02, 2.333700e-01
-3351, 2.535487e-02, 5.437951e-02, 2.430562e-01
-3352, 1.760354e-02, -5.735953e-02, 2.663438e-01
-3353, 4.821915e-03, -5.980593e-02, 2.621192e-01
-3354, 1.915131e-02, -5.686147e-02, 2.780976e-01
-3355, 2.710717e-02, 5.352758e-02, 8.761628e-02
-3356, 2.708789e-02, 5.353734e-02, 7.409719e-02
-3357, -1.455987e-02, 5.820662e-02, 3.822733e-01
-3358, 1.668133e-02, -5.763448e-02, 4.023671e-01
-3359, 3.434768e-02, -4.919591e-02, 3.579872e-01
-3360, 3.128971e-02, 5.119525e-02, 4.203359e-01
-3361, 3.086803e-02, 5.145060e-02, 4.296533e-01
-3362, -4.863055e-03, 5.980260e-02, 3.721296e-01
-3363, 2.559425e-02, 5.426725e-02, 1.226860e-01
-3364, 2.377545e-02, -5.508837e-02, 3.581540e-01
-3365, 2.803811e-02, -5.304587e-02, 3.493832e-01
-3366, 1.567947e-02, 5.791506e-02, 3.541545e-01
-3367, 3.222340e-03, 5.991341e-02, 3.499131e-01
-3368, 3.749029e-03, 5.988276e-02, 3.621559e-01
-3369, -3.774012e-02, 4.664422e-02, 8.417734e-02
-3370, -3.356838e-02, 4.973091e-02, 9.410388e-02
-3371, -4.592961e-02, 3.860662e-02, 8.481212e-02
-3372, -6.893762e-03, 5.960265e-02, 8.758189e-02
-3373, 5.736082e-03, 5.972518e-02, 9.667004e-02
-3374, 6.022326e-03, 5.969700e-02, 1.089036e-01
-3375, -1.488647e-02, 5.812394e-02, 9.721117e-02
-3376, 2.533608e-02, 5.438826e-02, 4.365442e-01
-3377, -3.389873e-02, -4.950632e-02, 2.154872e-01
-3378, -3.506706e-02, -4.868574e-02, 2.010698e-01
-3379, -2.413902e-02, -5.493003e-02, 1.932541e-01
-3380, 2.029257e-02, -5.646425e-02, 8.913170e-02
-3381, 2.225098e-02, -5.572158e-02, 7.489636e-02
-3382, -4.955346e-02, -3.382979e-02, 8.731117e-02
-3383, -5.308435e-02, -2.796520e-02, 9.639117e-02
-3384, -4.186600e-02, -4.297951e-02, 9.409183e-02
-3385, 2.577799e-02, 5.418021e-02, 1.571179e-01
-3386, 2.618174e-02, 5.398626e-02, 1.674744e-01
-3387, 1.206789e-02, -5.877385e-02, 3.604523e-01
-3388, 2.539037e-02, 5.436294e-02, 3.618036e-01
-3389, 2.814377e-02, 5.298989e-02, 3.706517e-01
-3390, 7.706098e-03, -5.950308e-02, 9.541980e-02
-3391, -5.701495e-02, 1.868946e-02, 8.404200e-02
-3392, -5.269115e-02, 2.869918e-02, 8.490696e-02
-3393, -4.951250e-02, 3.388970e-02, 9.606821e-02
-3394, -5.859970e-02, 1.288704e-02, 9.496375e-02
-3395, 8.219010e-03, 5.943440e-02, 4.386763e-01
-3396, 1.778378e-02, 5.730390e-02, 4.358293e-01
-3397, -1.368781e-02, -5.841784e-02, 3.326260e-01
-3398, 2.145661e-04, 5.999962e-02, 4.407144e-01
-3399, -9.258107e-03, 5.928143e-02, 4.393516e-01
-3400, -1.627538e-02, 5.775043e-02, 4.391694e-01
-3401, -2.220428e-02, 5.574020e-02, 4.365156e-01
-3402, -3.845887e-02, 4.605340e-02, 4.359363e-01
-3403, -4.391734e-02, 4.088114e-02, 4.343171e-01
-3404, -3.286771e-02, 5.019675e-02, 4.348136e-01
-3405, 3.167744e-03, -5.991632e-02, 3.484644e-01
-3406, -1.603854e-03, -5.997856e-02, 3.374412e-01
-3407, -9.489504e-03, 5.924483e-02, 2.463435e-01
-3408, -4.584502e-02, 3.870703e-02, 4.238154e-01
-3409, -5.113591e-02, 3.138660e-02, 4.328474e-01
-3410, -5.537619e-02, 2.309713e-02, 4.341086e-01
-3411, -1.088530e-02, 5.900432e-02, 3.437901e-01
-3412, -2.950324e-02, -5.224518e-02, 3.874569e-01
-3413, 1.264349e-02, -5.865273e-02, 7.234354e-02
-3414, 2.996740e-03, -5.992512e-02, 7.259996e-02
-3415, -5.868756e-02, 1.248081e-02, 4.337540e-01
-3416, -5.995281e-02, 2.379275e-03, 4.320341e-01
-3417, -5.918470e-02, -9.857557e-03, 4.317319e-01
-3418, -5.672407e-02, -1.955454e-02, 4.333076e-01
-3419, -5.089320e-02, -3.177864e-02, 4.343346e-01
-3420, -4.568301e-02, -3.889810e-02, 4.365683e-01
-3421, -5.932859e-02, -8.950887e-03, 4.100743e-01
-3422, -5.594074e-02, -2.169408e-02, 4.083204e-01
-3423, -4.012008e-02, -4.461367e-02, 4.337461e-01
-3424, -2.937992e-02, -5.231463e-02, 4.371103e-01
-3425, -2.197572e-02, -5.583071e-02, 4.403304e-01
-3426, -3.481805e-02, -4.886413e-02, 4.264505e-01
-3427, -2.532419e-02, -5.439380e-02, 1.637531e-01
-3428, -5.983638e-02, -4.427992e-03, 4.213343e-01
-3429, -5.990939e-02, 3.296264e-03, 4.103764e-01
-3430, -1.452714e-02, -5.821479e-02, 4.366977e-01
-3431, -4.843903e-03, -5.980415e-02, 4.327566e-01
-3432, 4.697588e-03, -5.981582e-02, 4.311269e-01
-3433, 2.266080e-02, -5.555617e-02, 4.340005e-01
-3434, 2.605760e-02, 5.404629e-02, 2.212073e-01
-3435, 1.447772e-02, 5.822710e-02, 2.278422e-01
-3436, 2.742389e-02, 5.336600e-02, 1.805238e-01
-3437, 1.577954e-02, 5.788788e-02, 1.765587e-01
-3438, 2.904003e-03, 5.992968e-02, 1.702412e-01
-3439, 4.289911e-03, 5.984644e-02, 1.832906e-01
-3440, 1.402449e-02, -5.833793e-02, 4.294094e-01
-3441, 2.311828e-02, -5.536737e-02, 4.230887e-01
-3442, 2.166982e-02, -5.595015e-02, 4.128053e-01
-3443, -5.702074e-02, 1.867176e-02, 4.219911e-01
-3444, -1.132961e-03, -5.998930e-02, 8.517129e-02
-3445, -5.251684e-02, -2.901692e-02, 4.220592e-01
-3446, 9.345286e-03, -5.926775e-02, 4.080594e-01
-3447, -4.280584e-03, -5.984711e-02, 9.788773e-02
-3448, -4.564702e-02, 3.894034e-02, 1.084040e-01
-3449, -1.923647e-02, -5.683272e-02, 1.011962e-01
-3450, -3.046881e-02, -5.168802e-02, 1.001544e-01
-3451, -1.066483e-02, -5.904457e-02, 1.114447e-01
-3452, 1.993830e-02, 5.659032e-02, 3.757024e-01
-3453, 3.155480e-02, 5.103229e-02, 3.799568e-01
-3454, -5.804162e-02, 1.520428e-02, 4.105794e-01
-3455, 2.454302e-02, 5.475071e-02, 1.349070e-01
-3456, 2.588109e-02, 5.413104e-02, 1.453938e-01
-3457, -1.282850e-02, -5.861254e-02, 1.256956e-01
-3458, 3.104987e-02, 5.134107e-02, 4.094410e-01
-3459, 2.170212e-02, 5.593762e-02, 4.148256e-01
-3460, -5.755203e-02, -1.696359e-02, 1.030228e-01
-3461, -5.960899e-02, -6.838723e-03, 1.048279e-01
-3462, -3.517437e-02, 4.860827e-02, 1.076281e-01
-3463, 2.315269e-02, 5.535299e-02, 3.210612e-01
-3464, 2.863231e-02, 5.272751e-02, 3.120919e-01
-3465, 1.581054e-02, 5.787942e-02, 3.103003e-01
-3466, -1.346782e-02, -5.846895e-02, 1.573558e-01
-3467, -1.312146e-02, -5.854765e-02, 1.427896e-01
-3468, 2.639286e-02, 5.388337e-02, 2.111308e-01
-3469, 1.797371e-03, 5.997307e-02, 2.232042e-01
-3470, 1.777413e-03, 5.997367e-02, 2.353669e-01
-3471, 2.519111e-02, 5.445556e-02, 2.820281e-01
-3472, 1.687043e-02, 5.757941e-02, 2.913324e-01
-3473, 2.961657e-02, 5.218102e-02, 2.920267e-01
-3474, -4.696944e-03, -5.981587e-02, 3.226883e-01
-3475, -6.778320e-03, -5.961589e-02, 3.108223e-01
-3476, -3.048570e-02, -5.167806e-02, 4.015837e-01
-3477, -2.055510e-02, -5.636921e-02, 3.927336e-01
-3478, -1.236283e-02, -5.871252e-02, 1.862809e-01
-3479, -1.300322e-02, -5.857402e-02, 1.721677e-01
-3480, 2.975077e-02, 5.210462e-02, 2.726064e-01
-3481, 1.701856e-02, 5.753580e-02, 2.719121e-01
-3482, 1.454671e-02, 5.820991e-02, 1.517852e-01
-3483, 2.760457e-02, 5.327277e-02, 1.980951e-01
-3484, 1.580997e-02, 5.787957e-02, 2.026437e-01
-3485, 1.580083e-03, 5.997919e-02, 2.893828e-01
-3486, 6.544409e-03, 5.964202e-02, 2.993814e-01
-3487, 4.787173e-04, 5.999809e-02, 3.083507e-01
-3488, 3.147232e-02, 5.108320e-02, 3.024007e-01
-3489, 7.170189e-03, 5.957003e-02, 2.622243e-01
-3490, 2.055350e-03, 5.996479e-02, 2.716460e-01
-3491, 1.064087e-03, 5.999056e-02, 1.442258e-01
-3492, 9.498796e-04, 5.999248e-02, 1.559499e-01
-3493, 3.812974e-03, 5.987872e-02, 1.963916e-01
-3494, 2.457962e-03, 5.994963e-02, 2.094273e-01
-3495, -5.902713e-02, 1.076094e-02, 3.993193e-01
-3496, 2.882693e-02, 5.262137e-02, 2.542990e-01
-3497, 3.176528e-02, 5.090154e-02, 2.626917e-01
-3498, 2.800125e-02, 5.306534e-02, 1.893761e-01
-3499, -1.729902e-03, -5.997506e-02, 3.593667e-01
-3500, 3.124938e-02, 5.121988e-02, 3.993867e-01
-3501, 1.401956e-02, -5.833911e-02, 2.853822e-01
-3502, -3.408579e-02, -4.937772e-02, 4.149733e-01
-3503, 3.223941e-02, 5.060257e-02, 3.899251e-01
-3504, 2.562622e-02, 5.425216e-02, 3.323822e-01
-3505, 2.621681e-02, 5.396924e-02, 3.415051e-01
-3506, 7.749648e-03, 5.949742e-02, 3.763710e-01
-3507, 2.491138e-02, 5.458409e-02, 3.495607e-01
-3508, -6.738042e-03, -5.962046e-02, 2.695135e-01
-3509, -8.436183e-03, -5.940396e-02, 2.558947e-01
-3510, -7.841989e-03, -5.948532e-02, 3.881140e-01
-3511, -6.285546e-03, -5.966986e-02, 3.749807e-01
-3512, 1.820307e-02, 5.717209e-02, 2.512477e-01
-3513, 4.924723e-03, -5.979755e-02, 2.897548e-01
-3514, -7.757014e-03, -5.949646e-02, 2.970732e-01
-3515, -6.159123e-03, -5.968304e-02, 2.830565e-01
-3516, 3.293209e-03, 5.990955e-02, 2.509816e-01
-3517, 1.577675e-02, 5.788864e-02, 1.278402e-01
-3518, -9.501558e-03, -5.924289e-02, 2.420105e-01
-3519, -1.085385e-02, -5.901012e-02, 2.284289e-01
-3520, -2.716603e-02, 5.349773e-02, 4.269870e-01
-3521, -2.246837e-02, 5.563427e-02, 2.875789e-01
-3522, -2.229058e-02, 5.570574e-02, 3.042305e-01
-3523, -1.092218e-02, 5.899751e-02, 3.135487e-01
-3524, -2.068761e-02, -5.632071e-02, 2.494047e-01
-3525, 5.190809e-03, -5.977504e-02, 4.202151e-01
-3526, 1.118114e-02, 5.894898e-02, 4.077808e-01
-3527, -1.174737e-02, -5.883876e-02, 2.146402e-01
-3528, -1.155486e-02, -5.887686e-02, 2.009700e-01
-3529, -2.254137e-02, -5.560474e-02, 2.217319e-01
-3530, -2.608908e-02, 5.403110e-02, 1.057586e-01
-3531, -8.459531e-03, 5.940064e-02, 2.796950e-01
-3532, 6.592619e-03, 5.963671e-02, 1.206767e-01
-3533, 5.441376e-03, 5.975275e-02, 1.328976e-01
-3534, -6.954757e-05, -5.999996e-02, 4.097769e-01
-3535, -5.377260e-02, -2.661780e-02, 1.092598e-01
-3536, -1.911516e-02, 5.687364e-02, 4.168616e-01
-3537, -8.965197e-03, -5.932643e-02, 4.022408e-01
-3538, -5.970022e-02, 5.990266e-03, 1.072590e-01
-3539, 5.449547e-02, 5.478803e-03, 5.000000e-01
-3540, 5.500000e-02, -6.123234e-18, 5.000000e-01
-3541, 5.262505e-02, 1.541304e-02, 5.000000e-01
-3542, 5.399606e-02, 1.045085e-02, 5.000000e-01
-3543, 4.891361e-02, 2.497451e-02, 5.000000e-01
-3544, 5.102060e-02, 2.047928e-02, 5.000000e-01
-3545, 4.344133e-02, 3.369238e-02, 5.000000e-01
-3546, 4.626080e-02, 2.960619e-02, 5.000000e-01
-3547, 3.640488e-02, 4.122610e-02, 5.000000e-01
-3548, 3.985962e-02, 3.766083e-02, 5.000000e-01
-3549, 3.217357e-02, 4.431680e-02, 5.000000e-01
-3550, 2.349670e-02, 4.953808e-02, 5.000000e-01
-3551, 2.814051e-02, 4.725428e-02, 5.000000e-01
-3552, 1.398207e-02, 5.309922e-02, 5.000000e-01
-3553, 1.874230e-02, 5.168975e-02, 5.000000e-01
-3554, 3.126434e-03, 5.487067e-02, 5.000000e-01
-3555, 8.575706e-03, 5.424954e-02, 5.000000e-01
-3556, -7.294820e-03, 5.451029e-02, 5.000000e-01
-3557, -2.339502e-03, 5.481234e-02, 5.000000e-01
-3558, -1.721973e-02, 5.223201e-02, 5.000000e-01
-3559, -1.238208e-02, 5.334713e-02, 5.000000e-01
-3560, -2.202523e-02, 5.022108e-02, 5.000000e-01
-3561, -3.137174e-02, 4.508271e-02, 5.000000e-01
-3562, -2.701381e-02, 4.787360e-02, 5.000000e-01
-3563, -3.917466e-02, 3.856701e-02, 5.000000e-01
-3564, -3.550452e-02, 4.191013e-02, 5.000000e-01
-3565, -4.577157e-02, 3.047946e-02, 5.000000e-01
-3566, -4.250125e-02, 3.469183e-02, 5.000000e-01
-3567, -5.055994e-02, 2.164893e-02, 5.000000e-01
-3568, -4.819464e-02, 2.611790e-02, 5.000000e-01
-3569, -5.211963e-02, 1.693578e-02, 5.000000e-01
-3570, -5.445822e-02, 6.866851e-03, 5.000000e-01
-3571, -5.368984e-02, 1.187805e-02, 5.000000e-01
-3572, -5.479470e-02, -3.974221e-03, 5.000000e-01
-3573, -5.492625e-02, 1.508758e-03, 5.000000e-01
-3574, -5.314162e-02, -1.411674e-02, 5.000000e-01
-3575, -5.411994e-02, -9.249573e-03, 5.000000e-01
-3576, -4.960009e-02, -2.376617e-02, 5.000000e-01
-3577, -5.136769e-02, -1.912699e-02, 5.000000e-01
-3578, -4.707395e-02, -2.807544e-02, 5.000000e-01
-3579, -4.103479e-02, -3.640663e-02, 5.000000e-01
-3580, -4.447990e-02, -3.233752e-02, 5.000000e-01
-3581, -3.383759e-02, -4.325338e-02, 5.000000e-01
-3582, -3.764603e-02, -4.006870e-02, 5.000000e-01
-3583, -2.527032e-02, -4.880703e-02, 5.000000e-01
-3584, -2.967463e-02, -4.623536e-02, 5.000000e-01
-3585, -1.551955e-02, -5.276157e-02, 5.000000e-01
-3586, -2.021115e-02, -5.099697e-02, 5.000000e-01
-3587, -5.719083e-03, -5.470055e-02, 5.000000e-01
-3588, -1.059116e-02, -5.374699e-02, 5.000000e-01
-3589, -7.564599e-04, -5.483756e-02, 5.000000e-01
-3590, 9.163385e-03, -5.413645e-02, 5.000000e-01
-3591, 4.246117e-03, -5.481973e-02, 5.000000e-01
-3592, 1.961823e-02, -5.136544e-02, 5.000000e-01
-3593, 1.488098e-02, -5.285031e-02, 5.000000e-01
-3594, 2.910926e-02, -4.666477e-02, 5.000000e-01
-3595, 2.463681e-02, -4.893830e-02, 5.000000e-01
-3596, 3.321580e-02, -4.361104e-02, 5.000000e-01
-3597, 4.058232e-02, -3.695581e-02, 5.000000e-01
-3598, 3.715083e-02, -4.054347e-02, 5.000000e-01
-3599, 4.675759e-02, -2.882228e-02, 5.000000e-01
-3600, 4.382982e-02, -3.316792e-02, 5.000000e-01
-3601, 5.131089e-02, -1.973487e-02, 5.000000e-01
-3602, 4.927480e-02, -2.426264e-02, 5.000000e-01
-3603, 5.408899e-02, -9.924769e-03, 5.000000e-01
-3604, 5.278592e-02, -1.496845e-02, 5.000000e-01
-3605, 5.458812e-02, -4.954092e-03, 5.000000e-01
-3606, 5.500000e-02, -6.123234e-18, 0.000000e+00
-3607, 5.449854e-02, 5.462238e-03, 0.000000e+00
-3608, 5.399913e-02, 1.043428e-02, 0.000000e+00
-3609, 5.263069e-02, 1.539785e-02, 0.000000e+00
-3610, 5.102623e-02, 2.046410e-02, 0.000000e+00
-3611, 4.892135e-02, 2.496103e-02, 0.000000e+00
-3612, 4.626854e-02, 2.959271e-02, 0.000000e+00
-3613, 4.345077e-02, 3.368087e-02, 0.000000e+00
-3614, 3.986906e-02, 3.764932e-02, 0.000000e+00
-3615, 3.641559e-02, 4.121673e-02, 0.000000e+00
-3616, 3.218520e-02, 4.430977e-02, 0.000000e+00
-3617, 2.815213e-02, 4.724726e-02, 0.000000e+00
-3618, 2.350875e-02, 4.953340e-02, 0.000000e+00
-3619, 1.875435e-02, 5.168507e-02, 0.000000e+00
-3620, 1.399408e-02, 5.309672e-02, 0.000000e+00
-3621, 8.587718e-03, 5.424704e-02, 0.000000e+00
-3622, 3.138048e-03, 5.487041e-02, 0.000000e+00
-3623, -2.327889e-03, 5.481208e-02, 0.000000e+00
-3624, -7.283970e-03, 5.451186e-02, 0.000000e+00
-3625, -1.237123e-02, 5.334870e-02, 0.000000e+00
-3626, -1.720991e-02, 5.223514e-02, 0.000000e+00
-3627, -2.201668e-02, 5.022557e-02, 0.000000e+00
-3628, -2.700526e-02, 4.787809e-02, 0.000000e+00
-3629, -3.136461e-02, 4.508820e-02, 0.000000e+00
-3630, -3.549738e-02, 4.191561e-02, 0.000000e+00
-3631, -3.916897e-02, 3.857312e-02, 0.000000e+00
-3632, -4.249557e-02, 3.469794e-02, 0.000000e+00
-3633, -4.576741e-02, 3.048593e-02, 0.000000e+00
-3634, -4.819048e-02, 2.612437e-02, 0.000000e+00
-3635, -5.055718e-02, 2.165540e-02, 0.000000e+00
-3636, -5.211813e-02, 1.694199e-02, 0.000000e+00
-3637, -5.368835e-02, 1.188426e-02, 0.000000e+00
-3638, -5.445783e-02, 6.872570e-03, 0.000000e+00
-3639, -5.492586e-02, 1.514476e-03, 0.000000e+00
-3640, -5.479529e-02, -3.969177e-03, 0.000000e+00
-3641, -5.412053e-02, -9.244529e-03, 0.000000e+00
-3642, -5.314285e-02, -1.411249e-02, 0.000000e+00
-3643, -5.136892e-02, -1.912274e-02, 0.000000e+00
-3644, -4.960172e-02, -2.376277e-02, 0.000000e+00
-3645, -4.707574e-02, -2.807289e-02, 0.000000e+00
-3646, -4.448169e-02, -3.233498e-02, 0.000000e+00
-3647, -4.103654e-02, -3.640490e-02, 0.000000e+00
-3648, -3.764778e-02, -4.006697e-02, 0.000000e+00
-3649, -3.383907e-02, -4.325234e-02, 0.000000e+00
-3650, -2.967611e-02, -4.623432e-02, 0.000000e+00
-3651, -2.527156e-02, -4.880644e-02, 0.000000e+00
-3652, -2.021240e-02, -5.099638e-02, 0.000000e+00
-3653, -1.552003e-02, -5.276143e-02, 0.000000e+00
-3654, -1.059164e-02, -5.374686e-02, 0.000000e+00
-3655, -5.718931e-03, -5.470056e-02, 0.000000e+00
-3656, -7.556537e-04, -5.483751e-02, 0.000000e+00
-3657, 4.246923e-03, -5.481969e-02, 0.000000e+00
-3658, 9.164811e-03, -5.413613e-02, 0.000000e+00
-3659, 1.488240e-02, -5.284999e-02, 0.000000e+00
-3660, 1.962019e-02, -5.136465e-02, 0.000000e+00
-3661, 2.463877e-02, -4.893750e-02, 0.000000e+00
-3662, 2.911162e-02, -4.666331e-02, 0.000000e+00
-3663, 3.321836e-02, -4.360877e-02, 0.000000e+00
-3664, 3.715339e-02, -4.054120e-02, 0.000000e+00
-3665, 4.058488e-02, -3.695264e-02, 0.000000e+00
-3666, 4.383238e-02, -3.316475e-02, 0.000000e+00
-3667, 4.675988e-02, -2.881814e-02, 0.000000e+00
-3668, 4.927709e-02, -2.425850e-02, 0.000000e+00
-3669, 5.131269e-02, -1.972979e-02, 0.000000e+00
-3670, 5.278772e-02, -1.496337e-02, 0.000000e+00
-3671, 5.408998e-02, -9.918813e-03, 0.000000e+00
-3672, 5.458912e-02, -4.948136e-03, 0.000000e+00
-3673, 4.974967e-02, 4.997062e-03, 4.939230e-01
-3674, 4.706148e-02, 1.688837e-02, 4.949755e-01
-3675, 4.858989e-02, 1.179079e-02, 4.949755e-01
-3676, 3.564153e-02, 3.506681e-02, 4.945522e-01
-3677, 3.918642e-02, 3.105518e-02, 4.945522e-01
-3678, 1.826730e-02, 4.654359e-02, 4.950504e-01
-3679, 2.302540e-02, 4.438278e-02, 4.950504e-01
-3680, -3.120547e-03, 4.990253e-02, 4.944178e-01
-3681, 2.353749e-03, 4.994457e-02, 4.944178e-01
-3682, -2.385881e-02, 4.394038e-02, 4.941522e-01
-3683, -1.886819e-02, 4.630325e-02, 4.941522e-01
-3684, -3.955783e-02, 3.058069e-02, 4.949433e-01
-3685, -3.622731e-02, 3.446131e-02, 4.949433e-01
-3686, -4.851895e-02, 1.207940e-02, 4.951260e-01
-3687, -4.696661e-02, 1.715045e-02, 4.951260e-01
-3688, -4.919031e-02, -8.961768e-03, 4.944121e-01
-3689, -4.986449e-02, -3.678721e-03, 4.944121e-01
-3690, -4.140656e-02, -2.802672e-02, 4.949576e-01
-3691, -4.399663e-02, -2.375493e-02, 4.949576e-01
-3692, -2.677791e-02, -4.222492e-02, 4.952017e-01
-3693, -3.096160e-02, -3.926041e-02, 4.952017e-01
-3694, -7.206662e-03, -4.947791e-02, 4.944196e-01
-3695, -1.214362e-02, -4.850291e-02, 4.944196e-01
-3696, 1.399929e-02, -4.800021e-02, 4.952784e-01
-3697, 8.276728e-03, -4.931020e-02, 4.952784e-01
-3698, 3.262748e-02, -3.788730e-02, 4.949791e-01
-3699, 2.868391e-02, -4.095404e-02, 4.949791e-01
-3700, 4.518196e-02, -2.141474e-02, 4.951979e-01
-3701, 4.270546e-02, -2.600469e-02, 4.951979e-01
-3702, 4.974981e-02, -4.995675e-03, 4.939230e-01
-3703, 4.926915e-02, -8.517684e-03, 6.176822e-03
-3704, 4.987364e-02, -3.552410e-03, 6.176822e-03
-3705, 4.987364e-02, -3.552410e-03, 1.206771e-02
-3706, 4.987364e-02, -3.552410e-03, 1.726873e-02
-3707, 4.978335e-02, -4.649553e-03, 2.369701e-02
-3708, 4.978335e-02, -4.649553e-03, 2.906449e-02
-3709, 4.932720e-02, -8.174820e-03, 1.878192e-02
-3710, 4.978643e-02, -4.616451e-03, 3.516665e-02
-3711, 4.978643e-02, -4.616451e-03, 4.151046e-02
-3712, 4.914141e-02, -9.226140e-03, 3.131237e-02
-3713, 4.975486e-02, -4.945059e-03, 4.748052e-02
-3714, 4.975486e-02, -4.945059e-03, 5.246375e-02
-3715, 4.908577e-02, -9.517755e-03, 4.338458e-02
-3716, 4.972245e-02, -5.260974e-03, 5.799079e-02
-3717, 4.972245e-02, -5.260974e-03, 6.350150e-02
-3718, 4.895836e-02, -1.015279e-02, 5.488168e-02
-3719, 4.971031e-02, -5.374447e-03, 6.919118e-02
-3720, 4.971031e-02, -5.374447e-03, 7.472431e-02
-3721, 4.886888e-02, -1.057511e-02, 6.609839e-02
-3722, 4.970357e-02, -5.436499e-03, 8.041971e-02
-3723, 4.970357e-02, -5.436499e-03, 8.628818e-02
-3724, 4.883123e-02, -1.074758e-02, 7.748347e-02
-3725, 4.970741e-02, -5.401247e-03, 9.181489e-02
-3726, 4.970741e-02, -5.401247e-03, 9.702713e-02
-3727, 4.882543e-02, -1.077391e-02, 8.870558e-02
-3728, 4.975557e-02, -4.937935e-03, 1.024545e-01
-3729, 4.975557e-02, -4.937935e-03, 1.078219e-01
-3730, 4.893099e-02, -1.028388e-02, 9.965964e-02
-3731, 4.975504e-02, -4.943231e-03, 1.136222e-01
-3732, 4.975504e-02, -4.943231e-03, 1.199548e-01
-3733, 4.902363e-02, -9.832808e-03, 1.108872e-01
-3734, 4.968399e-02, -5.612625e-03, 1.254029e-01
-3735, 4.968399e-02, -5.612625e-03, 1.303861e-01
-3736, 4.888569e-02, -1.049712e-02, 1.221356e-01
-3737, 4.967986e-02, -5.649067e-03, 1.358070e-01
-3738, 4.967986e-02, -5.649067e-03, 1.413177e-01
-3739, 4.873174e-02, -1.119005e-02, 1.330046e-01
-3740, 4.970055e-02, -5.463992e-03, 1.469347e-01
-3741, 4.970055e-02, -5.463992e-03, 1.524903e-01
-3742, 4.876500e-02, -1.104424e-02, 1.440424e-01
-3743, 4.971743e-02, -5.308250e-03, 1.582012e-01
-3744, 4.971743e-02, -5.308250e-03, 1.640473e-01
-3745, 4.883959e-02, -1.070957e-02, 1.553704e-01
-3746, 4.970275e-02, -5.443998e-03, 1.697220e-01
-3747, 4.970275e-02, -5.443998e-03, 1.749454e-01
-3748, 4.884389e-02, -1.068992e-02, 1.667560e-01
-3749, 4.968091e-02, -5.639770e-03, 1.805713e-01
-3750, 4.968091e-02, -5.639770e-03, 1.859388e-01
-3751, 4.877150e-02, -1.101550e-02, 1.780566e-01
-3752, 4.966242e-02, -5.800317e-03, 1.915645e-01
-3753, 4.966242e-02, -5.800317e-03, 1.978859e-01
-3754, 4.869124e-02, -1.136499e-02, 1.893083e-01
-3755, 4.965489e-02, -5.864477e-03, 2.034140e-01
-3756, 4.965489e-02, -5.864477e-03, 2.083973e-01
-3757, 4.863933e-02, -1.158516e-02, 2.004621e-01
-3758, 4.971109e-02, -5.367235e-03, 2.137335e-01
-3759, 4.971109e-02, -5.367235e-03, 2.192442e-01
-3760, 4.873845e-02, -1.116078e-02, 2.113265e-01
-3761, 4.973417e-02, -5.149023e-03, 2.248385e-01
-3762, 4.973417e-02, -5.149023e-03, 2.304165e-01
-3763, 4.889408e-02, -1.045797e-02, 2.222570e-01
-3764, 4.974495e-02, -5.043823e-03, 2.357725e-01
-3765, 4.974495e-02, -5.043823e-03, 2.415961e-01
-3766, 4.896106e-02, -1.013976e-02, 2.332073e-01
-3767, 4.974173e-02, -5.075413e-03, 2.472214e-01
-3768, 4.974173e-02, -5.075413e-03, 2.524560e-01
-3769, 4.897601e-02, -1.006729e-02, 2.441886e-01
-3770, 4.970861e-02, -5.390181e-03, 2.579509e-01
-3771, 4.970861e-02, -5.390181e-03, 2.633183e-01
-3772, 4.890470e-02, -1.040817e-02, 2.553086e-01
-3773, 4.970199e-02, -5.450906e-03, 2.689784e-01
-3774, 4.970199e-02, -5.450906e-03, 2.752886e-01
-3775, 4.882471e-02, -1.077719e-02, 2.664635e-01
-3776, 4.970085e-02, -5.461306e-03, 2.808095e-01
-3777, 4.970085e-02, -5.461306e-03, 2.857928e-01
-3778, 4.880924e-02, -1.084705e-02, 2.776446e-01
-3779, 4.975393e-02, -4.954478e-03, 2.911623e-01
-3780, 4.975393e-02, -4.954478e-03, 2.966730e-01
-3781, 4.891509e-02, -1.035926e-02, 2.885350e-01
-3782, 4.975393e-02, -4.954462e-03, 3.023675e-01
-3783, 4.975393e-02, -4.954462e-03, 3.079679e-01
-3784, 4.901813e-02, -9.860174e-03, 2.995991e-01
-3785, 4.970403e-02, -5.432250e-03, 3.134307e-01
-3786, 4.970403e-02, -5.432250e-03, 3.192319e-01
-3787, 4.892114e-02, -1.033065e-02, 3.107564e-01
-3788, 4.968730e-02, -5.583230e-03, 3.247136e-01
-3789, 4.968730e-02, -5.583230e-03, 3.299594e-01
-3790, 4.878659e-02, -1.094846e-02, 3.217009e-01
-3791, 4.972483e-02, -5.238460e-03, 3.354077e-01
-3792, 4.972483e-02, -5.238460e-03, 3.407752e-01
-3793, 4.882890e-02, -1.075820e-02, 3.326308e-01
-3794, 4.972229e-02, -5.262457e-03, 3.465549e-01
-3795, 4.972229e-02, -5.262457e-03, 3.528539e-01
-3796, 4.889731e-02, -1.044286e-02, 3.438588e-01
-3797, 4.965429e-02, -5.869501e-03, 3.583478e-01
-3798, 4.965429e-02, -5.869501e-03, 3.633310e-01
-3799, 4.876075e-02, -1.106297e-02, 3.551324e-01
-3800, 4.963922e-02, -5.995626e-03, 3.688734e-01
-3801, 4.963922e-02, -5.995626e-03, 3.743841e-01
-3802, 4.859219e-02, -1.178132e-02, 3.661687e-01
-3803, 4.965179e-02, -5.890652e-03, 3.800071e-01
-3804, 4.965179e-02, -5.890652e-03, 3.856299e-01
-3805, 4.858716e-02, -1.180202e-02, 3.773341e-01
-3806, 4.968936e-02, -5.564851e-03, 3.912243e-01
-3807, 4.968936e-02, -5.564851e-03, 3.970031e-01
-3808, 4.868770e-02, -1.138015e-02, 3.885515e-01
-3809, 4.974454e-02, -5.047873e-03, 4.024932e-01
-3810, 4.974454e-02, -5.047873e-03, 4.077503e-01
-3811, 4.887367e-02, -1.055293e-02, 3.996360e-01
-3812, 4.975172e-02, -4.976623e-03, 4.135423e-01
-3813, 4.975172e-02, -4.976623e-03, 4.196170e-01
-3814, 4.899509e-02, -9.974004e-03, 4.109181e-01
-3815, 4.968779e-02, -5.578859e-03, 4.251134e-01
-3816, 4.968779e-02, -5.578859e-03, 4.300967e-01
-3817, 4.888578e-02, -1.049670e-02, 4.222065e-01
-3818, 4.967787e-02, -5.666479e-03, 4.356247e-01
-3819, 4.967787e-02, -5.666479e-03, 4.411354e-01
-3820, 4.873542e-02, -1.117401e-02, 4.332310e-01
-3821, 4.970920e-02, -5.384737e-03, 4.467962e-01
-3822, 4.970920e-02, -5.384737e-03, 4.527977e-01
-3823, 4.877870e-02, -1.098357e-02, 4.444198e-01
-3824, 4.974556e-02, -5.037770e-03, 4.584495e-01
-3825, 4.974556e-02, -5.037770e-03, 4.638495e-01
-3826, 4.891370e-02, -1.036581e-02, 4.557323e-01
-3827, 4.979534e-02, -4.519330e-03, 4.692458e-01
-3828, 4.979534e-02, -4.519330e-03, 4.746922e-01
-3829, 4.908659e-02, -9.513482e-03, 4.667803e-01
-3830, 4.985448e-02, -3.811868e-03, 4.797147e-01
-3831, 4.985448e-02, -3.811868e-03, 4.850338e-01
-3832, 4.930588e-02, -8.302443e-03, 4.771991e-01
-3833, 4.974967e-02, 4.997062e-03, 5.890884e-03
-3834, 4.867761e-02, 1.142324e-02, 4.593200e-03
-3835, 4.718777e-02, 1.653223e-02, 4.593200e-03
-3836, 4.504990e-02, 2.169117e-02, 4.695294e-03
-3837, 4.247690e-02, 2.637637e-02, 4.695294e-03
-3838, 4.657048e-02, 1.819864e-02, 9.288494e-03
-3839, 3.938074e-02, 3.080840e-02, 4.825105e-03
-3840, 3.586112e-02, 3.484222e-02, 4.825105e-03
-3841, 4.147859e-02, 2.792000e-02, 9.520399e-03
-3842, 3.195650e-02, 3.845494e-02, 4.707247e-03
-3843, 2.795962e-02, 4.145189e-02, 4.707247e-03
-3844, 3.458059e-02, 3.611347e-02, 9.532352e-03
-3845, 2.331733e-02, 4.423010e-02, 4.538302e-03
-3846, 1.857357e-02, 4.642222e-02, 4.538302e-03
-3847, 2.609264e-02, 4.265178e-02, 9.245549e-03
-3848, 1.335211e-02, 4.818424e-02, 4.634240e-03
-3849, 7.943609e-03, 4.936496e-02, 4.634240e-03
-3850, 1.622558e-02, 4.729409e-02, 9.172542e-03
-3851, 2.664728e-03, 4.992894e-02, 5.064768e-03
-3852, -2.809723e-03, 4.992099e-02, 5.064768e-03
-3853, 5.687454e-03, 4.967548e-02, 9.699008e-03
-3854, -8.098808e-03, 4.933973e-02, 5.397653e-03
-3855, -1.320420e-02, 4.822498e-02, 5.397653e-03
-3856, -4.927061e-03, 4.975665e-02, 1.046242e-02
-3857, -1.822287e-02, 4.656100e-02, 4.945142e-03
-3858, -2.324584e-02, 4.426772e-02, 4.945142e-03
-3859, -1.529893e-02, 4.760192e-02, 1.034280e-02
-3860, -2.771728e-02, 4.161433e-02, 5.001033e-03
-3861, -3.190269e-02, 3.849959e-02, 5.001033e-03
-3862, -2.487862e-02, 4.337112e-02, 9.946175e-03
-3863, -3.572716e-02, 3.497956e-02, 5.347010e-03
-3864, -3.911323e-02, 3.114731e-02, 5.347010e-03
-3865, -3.330012e-02, 3.729748e-02, 1.034804e-02
-3866, -4.211131e-02, 2.695622e-02, 4.848064e-03
-3867, -4.459104e-02, 2.261944e-02, 4.848064e-03
-3868, -4.025803e-02, 2.965284e-02, 1.019507e-02
-3869, -4.671226e-02, 1.783157e-02, 4.938561e-03
-3870, -4.833817e-02, 1.278363e-02, 4.938561e-03
-3871, -4.551141e-02, 2.070535e-02, 9.786625e-03
-3872, -4.941472e-02, 7.627930e-03, 5.366674e-03
-3873, -4.994853e-02, 2.268132e-03, 5.366674e-03
-3874, -4.882962e-02, 1.075491e-02, 1.030524e-02
-3875, -4.990567e-02, -3.069856e-03, 5.439035e-03
-3876, -4.929602e-02, -8.360738e-03, 5.439035e-03
-3877, -4.999947e-02, 2.295870e-04, 1.080571e-02
-3878, -4.811580e-02, -1.359667e-02, 5.378719e-03
-3879, -4.639785e-02, -1.863437e-02, 5.378719e-03
-3880, -4.890550e-02, -1.040440e-02, 1.081775e-02
-3881, -4.415214e-02, -2.346463e-02, 5.183813e-03
-3882, -4.159026e-02, -2.775339e-02, 5.183813e-03
-3883, -4.558068e-02, -2.055241e-02, 1.056253e-02
-3884, -3.863102e-02, -3.174341e-02, 4.719400e-03
-3885, -3.527057e-02, -3.543991e-02, 4.719400e-03
-3886, -4.041365e-02, -2.944040e-02, 9.903213e-03
-3887, -3.134053e-02, -3.895858e-02, 4.697157e-03
-3888, -2.718576e-02, -4.196349e-02, 4.697157e-03
-3889, -3.357641e-02, -3.704895e-02, 9.416557e-03
-3890, -2.272132e-02, -4.453921e-02, 5.171522e-03
-3891, -1.767208e-02, -4.677283e-02, 5.171522e-03
-3892, -2.517262e-02, -4.320115e-02, 9.868678e-03
-3893, -1.248561e-02, -4.841601e-02, 5.614637e-03
-3894, -7.555655e-03, -4.942582e-02, 5.614637e-03
-3895, -1.551915e-02, -4.753058e-02, 1.078616e-02
-3896, -2.257982e-03, -4.994899e-02, 5.625281e-03
-3897, 2.750853e-03, -4.992427e-02, 5.625281e-03
-3898, -5.002220e-03, -4.974915e-02, 1.123992e-02
-3899, 8.072528e-03, -4.934404e-02, 5.484162e-03
-3900, 1.380046e-02, -4.805775e-02, 5.484162e-03
-3901, 5.658980e-03, -4.967873e-02, 1.110944e-02
-3902, 1.875725e-02, -4.634831e-02, 4.659443e-03
-3903, 2.380786e-02, -4.396801e-02, 4.659443e-03
-3904, 1.598684e-02, -4.737532e-02, 1.014360e-02
-3905, 2.838643e-02, -4.116079e-02, 4.362176e-03
-3906, 3.235213e-02, -3.812270e-02, 4.362176e-03
-3907, 2.561368e-02, -4.294111e-02, 9.021619e-03
-3908, 3.606703e-02, -3.462902e-02, 4.780732e-03
-3909, 3.934259e-02, -3.085710e-02, 4.780732e-03
-3910, 3.398420e-02, -3.667525e-02, 9.142908e-03
-3911, 4.204524e-02, -2.705915e-02, 4.794699e-03
-3912, 4.463517e-02, -2.253223e-02, 4.794699e-03
-3913, 4.045535e-02, -2.938307e-02, 9.575431e-03
-3914, 4.986091e-02, 3.726881e-03, 1.995448e-02
-3915, 4.986091e-02, 3.726881e-03, 1.475345e-02
-3916, 4.975048e-02, 4.988960e-03, 4.207603e-02
-3917, 4.975048e-02, 4.988960e-03, 3.573223e-02
-3918, 4.970464e-02, 5.426710e-03, 6.395588e-02
-3919, 4.970464e-02, 5.426710e-03, 5.844517e-02
-3920, 4.974043e-02, 5.088214e-03, 8.655506e-02
-3921, 4.974043e-02, 5.088214e-03, 8.068660e-02
-3922, 4.975297e-02, 4.964111e-03, 1.081632e-01
-3923, 4.975297e-02, 4.964111e-03, 1.027957e-01
-3924, 4.971976e-02, 5.286362e-03, 1.304897e-01
-3925, 4.971976e-02, 5.286362e-03, 1.255064e-01
-3926, 4.967579e-02, 5.684714e-03, 1.528713e-01
-3927, 4.967579e-02, 5.684714e-03, 1.473158e-01
-3928, 4.975157e-02, 4.978096e-03, 1.752754e-01
-3929, 4.975157e-02, 4.978096e-03, 1.700519e-01
-3930, 4.962518e-02, 6.110796e-03, 1.976041e-01
-3931, 4.962518e-02, 6.110796e-03, 1.912827e-01
-3932, 4.971205e-02, 5.358325e-03, 2.189050e-01
-3933, 4.971205e-02, 5.358325e-03, 2.133942e-01
-3934, 4.967249e-02, 5.713482e-03, 2.421119e-01
-3935, 4.967249e-02, 5.713482e-03, 2.362882e-01
-3936, 4.980940e-02, 4.361579e-03, 2.634416e-01
-3937, 4.980940e-02, 4.361579e-03, 2.580741e-01
-3938, 4.980144e-02, 4.451614e-03, 2.857518e-01
-3939, 4.980144e-02, 4.451614e-03, 2.807686e-01
-3940, 4.965170e-02, 5.891416e-03, 3.076918e-01
-3941, 4.965170e-02, 5.891416e-03, 3.020914e-01
-3942, 4.973559e-02, 5.135307e-03, 3.303195e-01
-3943, 4.973559e-02, 5.135307e-03, 3.250737e-01
-3944, 4.960154e-02, 6.299778e-03, 3.527674e-01
-3945, 4.960154e-02, 6.299778e-03, 3.464684e-01
-3946, 4.967269e-02, 5.711758e-03, 3.743192e-01
-3947, 4.967269e-02, 5.711758e-03, 3.688085e-01
-3948, 4.966420e-02, 5.785076e-03, 3.977450e-01
-3949, 4.966420e-02, 5.785076e-03, 3.919662e-01
-3950, 4.970078e-02, 5.461955e-03, 4.196912e-01
-3951, 4.970078e-02, 5.461955e-03, 4.136165e-01
-3952, 4.968360e-02, 5.616048e-03, 4.409304e-01
-3953, 4.968360e-02, 5.616048e-03, 4.354197e-01
-3954, 4.983512e-02, 4.057251e-03, 4.637218e-01
-3955, 4.983512e-02, 4.057251e-03, 4.583218e-01
-3956, 4.984023e-02, 3.993954e-03, 4.845795e-01
-3957, 4.984023e-02, 3.993954e-03, 4.792604e-01
-3958, 4.952500e-02, 6.875626e-03, 4.888985e-01
-3959, 4.954254e-02, -6.748056e-03, 4.893823e-01
-3960, 4.862042e-02, -1.166426e-02, 4.954593e-01
-3961, 4.721378e-02, -1.645780e-02, 4.954593e-01
-3962, 4.888391e-02, -1.050541e-02, 4.865701e-01
-3963, 4.957555e-02, 6.501148e-03, 1.048408e-02
-3964, 4.225749e-02, 2.672648e-02, 4.946986e-01
-3965, 4.486912e-02, 2.206269e-02, 4.946986e-01
-3966, 2.762523e-02, 4.167549e-02, 4.949914e-01
-3967, 3.164609e-02, 3.871079e-02, 4.949914e-01
-3968, 7.785618e-03, 4.939012e-02, 4.946695e-01
-3969, 1.319787e-02, 4.822672e-02, 4.946695e-01
-3970, 5.218914e-03, 4.972688e-02, 4.890874e-01
-3971, -1.360937e-02, 4.811221e-02, 4.942067e-01
-3972, -8.513540e-03, 4.926987e-02, 4.942067e-01
-3973, -3.261898e-02, 3.789462e-02, 4.943803e-01
-3974, -2.849272e-02, 4.108728e-02, 4.943803e-01
-3975, -4.491886e-02, 2.196124e-02, 4.954058e-01
-3976, -4.250317e-02, 2.633402e-02, 4.954058e-01
-3977, -4.996761e-02, 1.799440e-03, 4.945254e-01
-3978, -4.948411e-02, 7.164010e-03, 4.945254e-01
-3979, -4.620810e-02, -1.910004e-02, 4.946828e-01
-3980, -4.797663e-02, -1.407987e-02, 4.946828e-01
-3981, -3.486744e-02, -3.583659e-02, 4.952805e-01
-3982, -3.826949e-02, -3.217834e-02, 4.952805e-01
-3983, -1.717119e-02, -4.695903e-02, 4.945706e-01
-3984, -2.224402e-02, -4.477950e-02, 4.945706e-01
-3985, 3.005448e-03, -4.990959e-02, 4.945997e-01
-3986, -2.003196e-03, -4.995986e-02, 4.945997e-01
-3987, 2.418791e-02, -4.376008e-02, 4.953728e-01
-3988, 1.915812e-02, -4.618405e-02, 4.953728e-01
-3989, 3.967237e-02, -3.043195e-02, 4.949413e-01
-3990, 3.643759e-02, -3.423890e-02, 4.949413e-01
-3991, 2.546569e-02, 4.302904e-02, 4.900417e-01
-3992, 4.106811e-02, 2.852035e-02, 4.892508e-01
-3993, 4.809539e-02, -1.366869e-02, 7.346765e-03
-3994, 4.847117e-02, -1.226971e-02, 1.352359e-02
-3995, 4.649135e-02, -1.839984e-02, 7.346765e-03
-3996, 4.972988e-02, 5.190243e-03, 4.778594e-02
-3997, 4.896383e-02, 1.012635e-02, 4.425558e-02
-3998, 4.972988e-02, 5.190243e-03, 5.276918e-02
-3999, 4.627674e-02, 1.893312e-02, 4.896741e-01
-4000, 4.895306e-02, 1.017831e-02, 1.345577e-02
-4001, 4.981055e-02, 4.348430e-03, 3.019588e-02
-4002, 4.981055e-02, 4.348430e-03, 2.482840e-02
-4003, 4.887280e-02, 1.055698e-02, 5.564148e-02
-4004, 4.970504e-02, 5.423036e-03, 7.521761e-02
-4005, 4.970504e-02, 5.423036e-03, 6.968448e-02
-4006, 4.977716e-02, 4.715382e-03, 9.728974e-02
-4007, 4.977716e-02, 4.715382e-03, 9.207750e-02
-4008, 4.968995e-02, 5.559605e-03, 1.199835e-01
-4009, 4.968995e-02, 5.559605e-03, 1.136509e-01
-4010, 4.971250e-02, 5.354235e-03, 1.416652e-01
-4011, 4.971250e-02, 5.354235e-03, 1.361545e-01
-4012, 4.969377e-02, 5.525313e-03, 1.644614e-01
-4013, 4.969377e-02, 5.525313e-03, 1.586154e-01
-4014, 4.982928e-02, 4.128357e-03, 1.857621e-01
-4015, 4.982928e-02, 4.128357e-03, 1.803946e-01
-4016, 4.978893e-02, 4.589343e-03, 2.081450e-01
-4017, 4.978893e-02, 4.589343e-03, 2.031618e-01
-4018, 4.969181e-02, 5.542903e-03, 2.303749e-01
-4019, 4.969181e-02, 5.542903e-03, 2.247969e-01
-4020, 4.971518e-02, 5.329243e-03, 2.529516e-01
-4021, 4.971518e-02, 5.329243e-03, 2.477169e-01
-4022, 4.961677e-02, 6.178707e-03, 2.752920e-01
-4023, 4.961677e-02, 6.178707e-03, 2.689818e-01
-4024, 4.970661e-02, 5.408611e-03, 2.963978e-01
-4025, 4.970661e-02, 5.408611e-03, 2.908871e-01
-4026, 4.966751e-02, 5.756629e-03, 3.193504e-01
-4027, 4.966751e-02, 5.756629e-03, 3.135492e-01
-4028, 4.981767e-02, 4.266119e-03, 3.409126e-01
-4029, 4.981767e-02, 4.266119e-03, 3.355451e-01
-4030, 4.977382e-02, 4.750406e-03, 3.634258e-01
-4031, 4.977382e-02, 4.750406e-03, 3.584426e-01
-4032, 4.965185e-02, 5.890111e-03, 3.859886e-01
-4033, 4.965185e-02, 5.890111e-03, 3.803658e-01
-4034, 4.979359e-02, 4.538496e-03, 4.082135e-01
-4035, 4.979359e-02, 4.538496e-03, 4.029564e-01
-4036, 4.979340e-02, 4.540585e-03, 4.300292e-01
-4037, 4.979340e-02, 4.540585e-03, 4.250460e-01
-4038, 4.971530e-02, 5.328127e-03, 4.530348e-01
-4039, 4.971530e-02, 5.328127e-03, 4.470332e-01
-4040, 4.979111e-02, 4.565667e-03, 4.742152e-01
-4041, 4.979111e-02, 4.565667e-03, 4.687687e-01
-4042, 4.881753e-02, 1.080967e-02, 4.856320e-01
-4043, 4.647127e-02, -1.845050e-02, 4.906571e-01
-4044, 3.405965e-02, 3.660519e-02, 4.895436e-01
-4045, 1.576187e-02, 4.745064e-02, 4.897199e-01
-4046, -5.654895e-03, 4.967919e-02, 4.886245e-01
-4047, -2.628118e-02, 4.253586e-02, 4.885325e-01
-4048, -4.110407e-02, 2.846849e-02, 4.903491e-01
-4049, -4.907291e-02, 9.583792e-03, 4.896514e-01
-4050, -4.866178e-02, -1.149048e-02, 4.890949e-01
-4051, -3.988028e-02, -3.015897e-02, 4.902381e-01
-4052, -2.428717e-02, -4.370507e-02, 4.897723e-01
-4053, -4.397036e-03, -4.980629e-02, 4.890193e-01
-4054, 1.659211e-02, -4.716674e-02, 4.906512e-01
-4055, 3.463905e-02, -3.605741e-02, 4.899204e-01
-4056, 4.882283e-02, 1.078570e-02, 6.704607e-02
-4057, 4.903888e-02, 9.756438e-03, 8.923508e-02
-4058, 4.889247e-02, 1.046546e-02, 1.112571e-01
-4059, 4.886778e-02, 1.058019e-02, 1.334556e-01
-4060, 4.874335e-02, 1.113938e-02, 1.561656e-01
-4061, 4.917066e-02, 9.068943e-03, 1.782098e-01
-4062, 4.885480e-02, 1.063994e-02, 1.999280e-01
-4063, 4.881163e-02, 1.083628e-02, 2.218762e-01
-4064, 4.878056e-02, 1.097527e-02, 2.451999e-01
-4065, 4.888865e-02, 1.048330e-02, 2.665902e-01
-4066, 4.902767e-02, 9.812624e-03, 2.882190e-01
-4067, 4.864323e-02, 1.156877e-02, 3.105987e-01
-4068, 4.911606e-02, 9.360139e-03, 3.331283e-01
-4069, 4.877864e-02, 1.098383e-02, 3.551407e-01
-4070, 4.865396e-02, 1.152354e-02, 3.776278e-01
-4071, 4.893407e-02, 1.026921e-02, 4.008410e-01
-4072, 4.899941e-02, 9.952799e-03, 4.222132e-01
-4073, 4.880224e-02, 1.087848e-02, 4.444518e-01
-4074, 4.925643e-02, 8.590912e-03, 4.661755e-01
-4075, -3.451825e-02, 3.617306e-02, 4.893236e-01
-4076, -4.609745e-02, 1.936557e-02, 4.905318e-01
-4077, -4.999278e-02, -8.497132e-04, 4.889376e-01
-4078, -4.523232e-02, -2.130815e-02, 4.896404e-01
-4079, -3.279102e-02, -3.774584e-02, 4.904822e-01
-4080, -1.467333e-02, -4.779847e-02, 4.889902e-01
-4081, 6.117767e-03, -4.962432e-02, 4.898781e-01
-4082, 2.629359e-02, -4.252819e-02, 4.903519e-01
-4083, 4.147675e-02, -2.792274e-02, 4.901392e-01
-4084, 4.889675e-02, 1.044547e-02, 1.675001e-01
-4085, 4.895118e-02, 1.018734e-02, 1.888497e-01
-4086, 4.901038e-02, 9.898619e-03, 2.107349e-01
-4087, 4.873293e-02, 1.118486e-02, 2.336815e-01
-4088, 4.906079e-02, 9.645661e-03, 2.559275e-01
-4089, 4.886962e-02, 1.057166e-02, 2.776070e-01
-4090, 4.872306e-02, 1.122778e-02, 2.990478e-01
-4091, 4.881361e-02, 1.082734e-02, 3.221794e-01
-4092, 4.888315e-02, 1.050893e-02, 3.439097e-01
-4093, 4.890533e-02, 1.040523e-02, 3.661985e-01
-4094, 4.863690e-02, 1.159535e-02, 3.896520e-01
-4095, 4.899982e-02, 9.950743e-03, 4.114554e-01
-4096, 4.896831e-02, 1.010469e-02, 4.329585e-01
-4097, 4.911900e-02, 9.344706e-03, 4.558417e-01
-4098, 4.926730e-02, 8.528346e-03, 4.762677e-01
-4099, -1.635701e-02, 4.724879e-02, 4.883589e-01
-4100, 4.878140e-02, 1.097154e-02, 1.447710e-01
-4101, 4.882364e-02, 1.078202e-02, 1.222678e-01
-4102, 4.906307e-02, 9.634071e-03, 1.002635e-01
-4103, 4.912810e-02, 9.296787e-03, 3.300932e-02
-4104, 4.934787e-02, 8.049094e-03, 2.259905e-02
-4105, 4.889512e-02, 1.045308e-02, 7.824365e-02
-4106, 4.854903e-02, 1.195793e-02, 1.865936e-02
-4107, 4.780677e-02, 1.464624e-02, 1.439000e-02
-4108, 4.587536e-02, 1.988597e-02, 1.449209e-02
-4109, 4.839612e-02, 1.256247e-02, 2.353328e-02
-4110, 4.818929e-02, -1.333386e-02, 1.995187e-02
-4111, 1.368682e-02, 4.809024e-02, 4.836940e-01
-4112, 1.873890e-02, 4.635573e-02, 4.840748e-01
-4113, 3.988575e-02, 3.015173e-02, 4.825870e-01
-4114, 4.285711e-02, 2.575398e-02, 4.827333e-01
-4115, -8.212017e-03, 4.932102e-02, 4.823829e-01
-4116, -2.815255e-03, 4.992068e-02, 4.825940e-01
-4117, -2.904728e-02, 4.069712e-02, 4.815781e-01
-4118, -2.445249e-02, 4.361279e-02, 4.813500e-01
-4119, 4.693247e-02, 1.724364e-02, 1.475054e-01
-4120, 4.704611e-02, 1.693115e-02, 1.418549e-01
-4121, -4.274700e-02, 2.593634e-02, 4.858253e-01
-4122, -3.984140e-02, 3.021030e-02, 4.853628e-01
-4123, -4.937125e-02, 7.904395e-03, 4.830412e-01
-4124, -4.833257e-02, 1.280477e-02, 4.836417e-01
-4125, -4.799173e-02, -1.402833e-02, 4.829600e-01
-4126, -4.919991e-02, -8.908923e-03, 4.826893e-01
-4127, -3.795414e-02, -3.254970e-02, 4.849881e-01
-4128, -4.113151e-02, -2.842885e-02, 4.846652e-01
-4129, -2.223926e-02, -4.478186e-02, 4.833651e-01
-4130, -2.677342e-02, -4.222776e-02, 4.839963e-01
-4131, -1.217369e-02, -4.849537e-02, 4.825343e-01
-4132, -1.720031e-02, -4.694837e-02, 4.826853e-01
-4133, 9.392587e-03, -4.910987e-02, 4.844919e-01
-4134, 4.136252e-03, -4.982862e-02, 4.838132e-01
-4135, 2.838295e-02, -4.116319e-02, 4.846632e-01
-4136, 2.386651e-02, -4.393620e-02, 4.850569e-01
-4137, 4.313355e-02, -2.528828e-02, 4.848668e-01
-4138, 4.017478e-02, -2.976554e-02, 4.846102e-01
-4139, 4.716844e-02, 1.658729e-02, 7.036889e-02
-4140, 4.716722e-02, 1.659077e-02, 6.464030e-02
-4141, 4.737868e-02, 1.597688e-02, 1.713523e-01
-4142, 4.719998e-02, 1.649732e-02, 1.657618e-01
-4143, 2.324100e-02, 4.427026e-02, 4.852721e-01
-4144, 2.782761e-02, 4.154063e-02, 4.852131e-01
-4145, 2.129698e-02, 4.523758e-02, 4.792462e-01
-4146, 2.921540e-03, 4.991457e-02, 4.830793e-01
-4147, 8.346753e-03, 4.929839e-02, 4.833310e-01
-4148, 1.145587e-02, 4.866994e-02, 4.776859e-01
-4149, 3.408303e-04, 4.999884e-02, 4.768377e-01
-4150, 4.789329e-02, 1.436081e-02, 9.252660e-02
-4151, 4.778434e-02, 1.471926e-02, 8.700416e-02
-4152, 4.780906e-02, -1.463878e-02, 2.756733e-02
-4153, 4.781878e-02, -1.460699e-02, 3.366949e-02
-4154, 4.796098e-02, -1.413309e-02, 3.973549e-02
-4155, 4.786663e-02, -1.444944e-02, 4.570554e-02
-4156, 4.608977e-02, -1.938384e-02, 3.599045e-02
-4157, 4.737452e-02, -1.598922e-02, 5.119896e-02
-4158, 4.727201e-02, -1.628979e-02, 5.672600e-02
-4159, 4.564331e-02, -2.041294e-02, 4.754986e-02
-4160, 4.726802e-02, -1.630135e-02, 6.266820e-02
-4161, 4.723069e-02, -1.640919e-02, 6.835788e-02
-4162, 4.495424e-02, -2.188873e-02, 5.898548e-02
-4163, 4.713515e-02, -1.668167e-02, 7.447803e-02
-4164, 4.711428e-02, -1.674049e-02, 8.017343e-02
-4165, 4.482167e-02, -2.215893e-02, 7.104783e-02
-4166, 4.696895e-02, -1.714402e-02, 8.598619e-02
-4167, 4.698110e-02, -1.711071e-02, 9.151290e-02
-4168, 4.449902e-02, -2.279995e-02, 8.298075e-02
-4169, 4.717689e-02, -1.656325e-02, 9.717478e-02
-4170, 4.732914e-02, -1.612303e-02, 1.026021e-01
-4171, 4.456835e-02, -2.266411e-02, 9.445539e-02
-4172, 4.779920e-02, -1.467095e-02, 1.078330e-01
-4173, 4.779763e-02, -1.467604e-02, 1.136332e-01
-4174, 4.548388e-02, -2.076576e-02, 1.053481e-01
-4175, 4.722921e-02, -1.641345e-02, 1.187435e-01
-4176, 4.700396e-02, -1.704780e-02, 1.241916e-01
-4177, 4.535770e-02, -2.103993e-02, 1.156892e-01
-4178, 4.666758e-02, -1.794817e-02, 1.298037e-01
-4179, 4.665441e-02, -1.798239e-02, 1.352246e-01
-4180, 4.411402e-02, -2.353621e-02, 1.264117e-01
-4181, 4.690833e-02, -1.730921e-02, 1.409362e-01
-4182, 4.697247e-02, -1.713438e-02, 1.465531e-01
-4183, 4.399974e-02, -2.374916e-02, 1.377353e-01
-4184, 4.715147e-02, -1.663548e-02, 1.525273e-01
-4185, 4.720335e-02, -1.648767e-02, 1.582383e-01
-4186, 4.457944e-02, -2.264229e-02, 1.494211e-01
-4187, 4.721600e-02, -1.645143e-02, 1.639017e-01
-4188, 4.717090e-02, -1.658031e-02, 1.695764e-01
-4189, 4.483396e-02, -2.213404e-02, 1.610587e-01
-4190, 4.704769e-02, -1.692675e-02, 1.754700e-01
-4191, 4.698064e-02, -1.711197e-02, 1.810959e-01
-4192, 4.468721e-02, -2.242885e-02, 1.726157e-01
-4193, 4.667944e-02, -1.791731e-02, 1.867988e-01
-4194, 4.662128e-02, -1.806810e-02, 1.924246e-01
-4195, 4.412315e-02, -2.351908e-02, 1.842123e-01
-4196, 4.650152e-02, -1.837412e-02, 1.982646e-01
-4197, 4.647774e-02, -1.843419e-02, 2.037927e-01
-4198, 4.355171e-02, -2.456112e-02, 1.957552e-01
-4199, 4.661011e-02, -1.809691e-02, 2.095442e-01
-4200, 4.678889e-02, -1.762953e-02, 2.148805e-01
-4201, 4.356825e-02, -2.453176e-02, 2.073468e-01
-4202, 4.740672e-02, -1.589348e-02, 2.198754e-01
-4203, 4.747601e-02, -1.568528e-02, 2.254697e-01
-4204, 4.460746e-02, -2.258705e-02, 2.180932e-01
-4205, 4.714205e-02, -1.666216e-02, 2.307740e-01
-4206, 4.717718e-02, -1.656241e-02, 2.361301e-01
-4207, 4.496767e-02, -2.186111e-02, 2.283925e-01
-4208, 4.762365e-02, -1.523115e-02, 2.412974e-01
-4209, 4.761397e-02, -1.526139e-02, 2.469227e-01
-4210, 4.512898e-02, -2.152615e-02, 2.388642e-01
-4211, 4.730289e-02, -1.619990e-02, 2.521791e-01
-4212, 4.719939e-02, -1.649901e-02, 2.576740e-01
-4213, 4.530628e-02, -2.115044e-02, 2.492880e-01
-4214, 4.707925e-02, -1.683878e-02, 2.636307e-01
-4215, 4.705864e-02, -1.689628e-02, 2.692908e-01
-4216, 4.471916e-02, -2.236507e-02, 2.605012e-01
-4217, 4.691803e-02, -1.728290e-02, 2.751150e-01
-4218, 4.691441e-02, -1.729271e-02, 2.806359e-01
-4219, 4.436863e-02, -2.305264e-02, 2.722822e-01
-4220, 4.711963e-02, -1.672543e-02, 2.862511e-01
-4221, 4.728765e-02, -1.624433e-02, 2.916207e-01
-4222, 4.445677e-02, -2.288221e-02, 2.837216e-01
-4223, 4.778749e-02, -1.470902e-02, 2.967494e-01
-4224, 4.778750e-02, -1.470901e-02, 3.024438e-01
-4225, 4.542774e-02, -2.088829e-02, 2.944654e-01
-4226, 4.728207e-02, -1.626056e-02, 3.075925e-01
-4227, 4.712366e-02, -1.671408e-02, 3.130553e-01
-4228, 4.542056e-02, -2.090390e-02, 3.047428e-01
-4229, 4.689644e-02, -1.734139e-02, 3.187061e-01
-4230, 4.684354e-02, -1.748379e-02, 3.241877e-01
-4231, 4.441169e-02, -2.296958e-02, 3.155422e-01
-4232, 4.691616e-02, -1.728797e-02, 3.300226e-01
-4233, 4.703494e-02, -1.696214e-02, 3.354709e-01
-4234, 4.419927e-02, -2.337573e-02, 3.270278e-01
-4235, 4.748774e-02, -1.564974e-02, 3.408028e-01
-4236, 4.748019e-02, -1.567265e-02, 3.465825e-01
-4237, 4.492331e-02, -2.195213e-02, 3.381946e-01
-4238, 4.688971e-02, -1.735958e-02, 3.517541e-01
-4239, 4.667414e-02, -1.793111e-02, 3.572480e-01
-4240, 4.474670e-02, -2.230992e-02, 3.486981e-01
-4241, 4.645944e-02, -1.848028e-02, 3.630660e-01
-4242, 4.641234e-02, -1.859825e-02, 3.686084e-01
-4243, 4.363592e-02, -2.441120e-02, 3.596877e-01
-4244, 4.642212e-02, -1.857382e-02, 3.746279e-01
-4245, 4.646129e-02, -1.847562e-02, 3.802509e-01
-4246, 4.335812e-02, -2.490127e-02, 3.715252e-01
-4247, 4.659671e-02, -1.813137e-02, 3.862279e-01
-4248, 4.671463e-02, -1.782535e-02, 3.918223e-01
-4249, 4.355410e-02, -2.455688e-02, 3.835217e-01
-4250, 4.702758e-02, -1.698255e-02, 3.974740e-01
-4251, 4.720162e-02, -1.649264e-02, 4.029641e-01
-4252, 4.416324e-02, -2.344373e-02, 3.951504e-01
-4253, 4.773391e-02, -1.488199e-02, 4.081250e-01
-4254, 4.775518e-02, -1.481361e-02, 4.139170e-01
-4255, 4.532014e-02, -2.112072e-02, 4.059630e-01
-4256, 4.723766e-02, -1.638914e-02, 4.192103e-01
-4257, 4.703568e-02, -1.696009e-02, 4.247067e-01
-4258, 4.533617e-02, -2.108629e-02, 4.164172e-01
-4259, 4.677210e-02, -1.767401e-02, 4.305353e-01
-4260, 4.674086e-02, -1.775647e-02, 4.360633e-01
-4261, 4.426315e-02, -2.325453e-02, 4.275390e-01
-4262, 4.686825e-02, -1.741744e-02, 4.420840e-01
-4263, 4.696625e-02, -1.715144e-02, 4.477448e-01
-4264, 4.407624e-02, -2.360689e-02, 4.393883e-01
-4265, 4.728441e-02, -1.625375e-02, 4.537287e-01
-4266, 4.739667e-02, -1.592343e-02, 4.593805e-01
-4267, 4.468161e-02, -2.244001e-02, 4.513929e-01
-4268, 4.769860e-02, -1.499479e-02, 4.654025e-01
-4269, 4.785220e-02, -1.449713e-02, 4.707988e-01
-4270, 4.551385e-02, -2.069999e-02, 4.633989e-01
-4271, 4.820750e-02, -1.326790e-02, 4.764423e-01
-4272, 4.839102e-02, -1.258210e-02, 4.814648e-01
-4273, 4.756394e-02, -1.541661e-02, 4.858133e-01
-4274, 4.640123e-02, -1.862595e-02, 4.750645e-01
-4275, 4.344207e-02, 2.475452e-02, 1.499345e-02
-4276, 4.051538e-02, 2.930024e-02, 1.512326e-02
-4277, 4.518005e-02, 2.141875e-02, 2.009495e-02
-4278, 3.697337e-02, 3.365961e-02, 1.531204e-02
-4279, 3.318810e-02, 3.739720e-02, 1.519418e-02
-4280, 3.937666e-02, 3.081362e-02, 2.078509e-02
-4281, 2.891705e-02, 4.078976e-02, 1.451601e-02
-4282, 2.434069e-02, 4.367529e-02, 1.434706e-02
-4283, 3.164350e-02, 3.871290e-02, 2.029570e-02
-4284, 1.919133e-02, 4.617026e-02, 1.402388e-02
-4285, 1.399384e-02, 4.800180e-02, 1.411982e-02
-4286, 2.226946e-02, 4.476685e-02, 1.929434e-02
-4287, 8.569346e-03, 4.926019e-02, 1.495511e-02
-4288, 3.298046e-03, 4.989111e-02, 1.538563e-02
-4289, 1.167515e-02, 4.861780e-02, 1.980645e-02
-4290, -1.928933e-03, 4.996278e-02, 1.646659e-02
-4291, -7.227445e-03, 4.947488e-02, 1.679948e-02
-4292, 9.825961e-04, 4.999034e-02, 2.172269e-02
-4293, -1.247418e-02, 4.841895e-02, 1.679385e-02
-4294, -1.751742e-02, 4.683097e-02, 1.634134e-02
-4295, -9.542787e-03, 4.908090e-02, 2.279802e-02
-4296, -2.216884e-02, 4.481676e-02, 1.493523e-02
-4297, -2.670312e-02, 4.227225e-02, 1.499112e-02
-4298, -1.949594e-02, 4.604246e-02, 2.138629e-02
-4299, -3.077945e-02, 3.940337e-02, 1.625382e-02
-4300, -3.470382e-02, 3.599507e-02, 1.659980e-02
-4301, -2.830214e-02, 4.121879e-02, 2.124288e-02
-4302, -3.846556e-02, 3.194371e-02, 1.653006e-02
-4303, -4.154904e-02, 2.781505e-02, 1.603111e-02
-4304, -3.628525e-02, 3.440030e-02, 2.243584e-02
-4305, -4.416218e-02, 2.344573e-02, 1.471141e-02
-4306, -4.637217e-02, 1.869818e-02, 1.480191e-02
-4307, -4.272405e-02, 2.597413e-02, 2.104640e-02
-4308, -4.796812e-02, 1.410883e-02, 1.606967e-02
-4309, -4.918613e-02, 8.984700e-03, 1.649778e-02
-4310, -4.701710e-02, 1.701152e-02, 2.099446e-02
-4311, -4.987268e-02, 3.565860e-03, 1.665575e-02
-4312, -4.996861e-02, -1.771439e-03, 1.672811e-02
-4313, -4.950627e-02, 7.009209e-03, 2.242018e-02
-4314, -4.944697e-02, -7.415992e-03, 1.668834e-02
-4315, -4.836715e-02, -1.267355e-02, 1.662802e-02
-4316, -4.983165e-02, -4.099546e-03, 2.253838e-02
-4317, -4.666428e-02, -1.795676e-02, 1.650919e-02
-4318, -4.448914e-02, -2.281921e-02, 1.631429e-02
-4319, -4.766841e-02, -1.509049e-02, 2.237977e-02
-4320, -4.184691e-02, -2.736487e-02, 1.616354e-02
-4321, -3.892496e-02, -3.138228e-02, 1.569912e-02
-4322, -4.331950e-02, -2.496840e-02, 2.211020e-02
-4323, -3.571057e-02, -3.499651e-02, 1.434018e-02
-4324, -3.182480e-02, -3.856400e-02, 1.431794e-02
-4325, -3.743001e-02, -3.315108e-02, 2.060051e-02
-4326, -2.792605e-02, -4.147452e-02, 1.527270e-02
-4327, -2.350801e-02, -4.412905e-02, 1.574707e-02
-4328, -3.033207e-02, -3.974878e-02, 2.019633e-02
-4329, -1.837033e-02, -4.650302e-02, 1.640303e-02
-4330, -1.320904e-02, -4.822366e-02, 1.684615e-02
-4331, -2.135264e-02, -4.521134e-02, 2.180706e-02
-4332, -7.715549e-03, -4.940112e-02, 1.759949e-02
-4333, -2.419597e-03, -4.994142e-02, 1.761014e-02
-4334, -1.069439e-02, -4.884291e-02, 2.321636e-02
-4335, 3.259120e-03, -4.989367e-02, 1.757422e-02
-4336, 8.574611e-03, -4.925927e-02, 1.743310e-02
-4337, 5.255220e-04, -4.999724e-02, 2.393380e-02
-4338, 1.405910e-02, -4.798272e-02, 1.684399e-02
-4339, 1.900661e-02, -4.624661e-02, 1.601927e-02
-4340, 1.173119e-02, -4.860431e-02, 2.330877e-02
-4341, 2.329890e-02, -4.423982e-02, 1.388818e-02
-4342, 2.790956e-02, -4.148562e-02, 1.359092e-02
-4343, 2.149190e-02, -4.514530e-02, 2.058857e-02
-4344, 3.180508e-02, -3.858027e-02, 1.383501e-02
-4345, 3.556944e-02, -3.513993e-02, 1.425356e-02
-4346, 2.971298e-02, -4.021366e-02, 1.870157e-02
-4347, 3.907213e-02, -3.119886e-02, 1.641773e-02
-4348, 4.180778e-02, -2.742462e-02, 1.643170e-02
-4349, 3.720136e-02, -3.340746e-02, 2.110983e-02
-4350, 4.720670e-02, 1.647810e-02, 8.200727e-02
-4351, 4.709467e-02, 1.679560e-02, 7.653829e-02
-4352, 4.472739e-02, 2.234862e-02, 7.413251e-02
-4353, 4.543222e-02, 2.087854e-02, 8.529880e-02
-4354, 4.747290e-02, 1.569469e-02, 4.640445e-02
-4355, 4.753603e-02, 1.550245e-02, 4.069454e-02
-4356, 4.514623e-02, -2.148994e-02, 1.214146e-02
-4357, 4.641799e-02, -1.858414e-02, 2.230899e-02
-4358, 4.719442e-02, 1.651324e-02, 5.816303e-02
-4359, 4.727242e-02, 1.628859e-02, 5.248704e-02
-4360, 4.517060e-02, 2.143868e-02, 4.892599e-02
-4361, 4.486207e-02, 2.207701e-02, 6.148585e-02
-4362, 4.548707e-02, 2.075878e-02, 4.839317e-01
-4363, 4.752921e-02, 1.552335e-02, 4.842086e-01
-4364, 4.461382e-02, 2.257449e-02, 4.772678e-01
-4365, 4.696808e-02, 1.714640e-02, 1.134750e-01
-4366, 4.717006e-02, 1.658268e-02, 1.079873e-01
-4367, 4.793576e-02, 1.421840e-02, 3.475485e-02
-4368, 4.811474e-02, 1.360045e-02, 2.921850e-02
-4369, 4.687722e-02, 1.739329e-02, 2.527880e-02
-4370, 4.598068e-02, 1.964121e-02, 3.690371e-02
-4371, 4.741913e-02, 1.585644e-02, 1.361838e-01
-4372, 4.744073e-02, 1.579168e-02, 1.305190e-01
-4373, 4.494437e-02, 2.190898e-02, 1.389182e-01
-4374, 4.783764e-02, 1.454511e-02, 1.027394e-01
-4375, 4.790974e-02, 1.430583e-02, 9.723349e-02
-4376, 4.619597e-02, 1.912936e-02, 9.500257e-02
-4377, 4.535754e-02, 2.104029e-02, 1.049573e-01
-4378, 4.699361e-02, 1.707631e-02, 1.595379e-01
-4379, 4.693858e-02, 1.722699e-02, 1.537939e-01
-4380, 4.444242e-02, 2.291007e-02, 1.508778e-01
-4381, 4.472863e-02, 2.234613e-02, 1.633901e-01
-4382, 4.697221e-02, 1.713509e-02, 1.250827e-01
-4383, 4.687730e-02, 1.739305e-02, 1.195597e-01
-4384, 4.481868e-02, 2.216497e-02, 1.278109e-01
-4385, 4.812497e-02, 1.356419e-02, 1.829686e-01
-4386, 4.788649e-02, 1.438347e-02, 1.778494e-01
-4387, 4.570366e-02, 2.027746e-02, 1.761111e-01
-4388, 4.754620e-02, 1.547121e-02, 1.884892e-01
-4389, 4.755427e-02, 1.544642e-02, 2.058547e-01
-4390, 4.705932e-02, 1.689440e-02, 2.002970e-01
-4391, 4.730985e-02, 1.617956e-02, 2.111039e-01
-4392, 4.719897e-02, 1.650021e-02, 2.244808e-01
-4393, 4.725992e-02, 1.632481e-02, 2.185888e-01
-4394, 4.691161e-02, 1.730031e-02, 2.491269e-01
-4395, 4.677644e-02, 1.766251e-02, 2.435218e-01
-4396, 4.786427e-02, 1.445723e-02, 2.608400e-01
-4397, 4.757412e-02, 1.538516e-02, 2.557174e-01
-4398, 4.496754e-02, 2.186139e-02, 2.540394e-01
-4399, 4.730404e-02, 1.619654e-02, 2.663802e-01
-4400, 4.779115e-02, 1.469713e-02, 2.834804e-01
-4401, 4.725183e-02, 1.634822e-02, 2.780038e-01
-4402, 4.749965e-02, 1.561357e-02, 2.886157e-01
-4403, 4.679751e-02, 1.760663e-02, 3.008656e-01
-4404, 4.696640e-02, 1.715101e-02, 2.951720e-01
-4405, 4.720233e-02, 1.649062e-02, 3.257457e-01
-4406, 4.699250e-02, 1.707938e-02, 3.200224e-01
-4407, 4.800411e-02, 1.398590e-02, 3.377338e-01
-4408, 4.775259e-02, 1.482194e-02, 3.325081e-01
-4409, 4.542133e-02, 2.090221e-02, 3.303512e-01
-4410, 4.739202e-02, 1.593726e-02, 3.432895e-01
-4411, 4.740457e-02, 1.589991e-02, 3.612469e-01
-4412, 4.688585e-02, 1.737000e-02, 3.555717e-01
-4413, 4.708833e-02, 1.681337e-02, 3.666295e-01
-4414, 4.688793e-02, 1.736440e-02, 3.807046e-01
-4415, 4.694999e-02, 1.719590e-02, 3.746579e-01
-4416, 4.752388e-02, 1.553965e-02, 4.070998e-01
-4417, 4.711947e-02, 1.672589e-02, 4.018883e-01
-4418, 4.722726e-02, 1.641909e-02, 4.125028e-01
-4419, 4.754219e-02, 1.548356e-02, 4.275433e-01
-4420, 4.724728e-02, 1.636136e-02, 4.221885e-01
-4421, 4.719632e-02, 1.650779e-02, 4.329338e-01
-4422, 4.717279e-02, 1.657492e-02, 4.482025e-01
-4423, 4.707598e-02, 1.684792e-02, 4.420997e-01
-4424, 4.790826e-02, 1.431077e-02, 4.672271e-01
-4425, 4.805183e-02, 1.382107e-02, 4.621802e-01
-4426, -3.698103e-02, 3.365121e-02, 4.831578e-01
-4427, -3.344956e-02, 3.716352e-02, 4.825948e-01
-4428, -3.184239e-02, 3.854948e-02, 4.754122e-01
-4429, -3.894420e-02, 3.135840e-02, 4.786340e-01
-4430, -1.911723e-02, 4.620099e-02, 4.814155e-01
-4431, -1.386823e-02, 4.803824e-02, 4.814700e-01
-4432, -1.110874e-02, 4.875034e-02, 4.754395e-01
-4433, -2.214247e-02, 4.482980e-02, 4.744611e-01
-4434, 4.834895e-02, 1.274281e-02, 4.798896e-01
-4435, 3.196911e-02, 3.844446e-02, 4.837526e-01
-4436, 3.593390e-02, 3.476715e-02, 4.833135e-01
-4437, 3.814542e-02, 3.232532e-02, 4.767959e-01
-4438, 2.996948e-02, 4.002287e-02, 4.789830e-01
-4439, 4.564150e-02, -2.041698e-02, 4.855518e-01
-4440, 4.411837e-02, -2.352805e-02, 1.898376e-02
-4441, 4.819953e-02, 1.329683e-02, 4.748443e-01
-4442, -4.697308e-02, 1.713270e-02, 4.856644e-01
-4443, -4.492715e-02, 2.194427e-02, 4.859442e-01
-4444, -4.989997e-02, -3.161183e-03, 4.823177e-01
-4445, -4.994625e-02, 2.317753e-03, 4.824310e-01
-4446, -4.398666e-02, -2.377338e-02, 4.842085e-01
-4447, -4.620008e-02, -1.911942e-02, 4.839338e-01
-4448, -3.072899e-02, -3.944273e-02, 4.856806e-01
-4449, -3.465501e-02, -3.604206e-02, 4.857594e-01
-4450, -1.988594e-02, -4.587537e-02, 4.769093e-01
-4451, -1.226364e-03, -4.998496e-02, 4.827404e-01
-4452, -6.436693e-03, -4.958396e-02, 4.825603e-01
-4453, 1.928815e-02, -4.612990e-02, 4.861179e-01
-4454, 1.413445e-02, -4.796058e-02, 4.860235e-01
-4455, 1.221284e-02, -4.848553e-02, 4.799585e-01
-4456, 2.156596e-02, -4.510997e-02, 4.804292e-01
-4457, 3.652976e-02, -3.414054e-02, 4.843931e-01
-4458, 3.272951e-02, -3.779920e-02, 4.844309e-01
-4459, 4.429244e-02, 2.319869e-02, 1.162899e-01
-4460, 4.467392e-02, -2.245532e-02, 4.800229e-01
-4461, -4.714385e-02, -1.665705e-02, 4.775281e-01
-4462, 4.346255e-02, -2.471855e-02, 2.659922e-02
-4463, 4.649660e-02, 1.838659e-02, 4.708490e-01
-4464, -4.968402e-02, 5.612304e-03, 4.764213e-01
-4465, -2.887138e-02, -4.082210e-02, 4.792734e-01
-4466, -4.394160e-02, 2.385657e-02, 4.809579e-01
-4467, -4.966532e-02, -5.775490e-03, 4.761827e-01
-4468, 4.571124e-02, 2.026037e-02, 3.487083e-01
-4469, 4.414136e-02, 2.348489e-02, 3.425323e-01
-4470, 4.340735e-02, 2.481537e-02, 3.548144e-01
-4471, 4.565617e-02, 2.038416e-02, 2.723226e-01
-4472, 4.383074e-02, 2.405965e-02, 2.665724e-01
-4473, 4.375332e-02, 2.420014e-02, 2.781960e-01
-4474, 4.586609e-02, 1.990733e-02, 1.939840e-01
-4475, 4.437193e-02, 2.304630e-02, 1.881029e-01
-4476, 4.365861e-02, 2.437058e-02, 1.999107e-01
-4477, 4.500179e-02, 2.179080e-02, 2.904335e-01
-4478, 4.507937e-02, 2.162986e-02, 2.137086e-01
-4479, 4.698133e-02, 1.711007e-02, 2.313240e-01
-4480, 4.472703e-02, 2.234933e-02, 2.280367e-01
-4481, 4.692231e-02, 1.727127e-02, 2.372373e-01
-4482, 4.424084e-02, 2.329695e-02, 2.411644e-01
-4483, 4.468958e-02, 2.242412e-02, 3.697062e-01
-4484, 4.666379e-02, 1.795804e-02, 3.076541e-01
-4485, 4.409281e-02, 2.357592e-02, 3.037783e-01
-4486, 4.671236e-02, 1.783131e-02, 3.135115e-01
-4487, 4.429228e-02, 2.319901e-02, 3.170778e-01
-4488, 4.504316e-02, 2.170516e-02, 4.178329e-01
-4489, 4.670238e-02, 1.785743e-02, 3.880311e-01
-4490, 4.426313e-02, 2.325457e-02, 3.850612e-01
-4491, 4.674005e-02, 1.775860e-02, 3.940086e-01
-4492, 4.452692e-02, 2.274541e-02, 4.002674e-01
-4493, 4.491225e-02, 2.197475e-02, 4.366845e-01
-4494, 4.768334e-02, 1.504324e-02, 4.568932e-01
-4495, -4.244468e-02, -2.642818e-02, 4.789586e-01
-4496, 3.055757e-02, -3.957568e-02, 4.791359e-01
-4497, 3.858297e-02, -3.180179e-02, 4.791207e-01
-4498, -9.070553e-03, -4.917037e-02, 4.762554e-01
-4499, -4.753013e-02, 1.552053e-02, 4.790541e-01
-4500, -3.616217e-02, -3.452966e-02, 4.801865e-01
-4501, 2.088494e-03, -4.995636e-02, 4.773541e-01
-4502, 4.544912e-02, 2.084173e-02, 4.545410e-01
-4503, 4.303502e-02, 2.545558e-02, 1.808664e-01
-4504, 4.215965e-02, 2.688055e-02, 1.743693e-01
-4505, 4.042904e-02, 2.941926e-02, 1.863611e-01
-4506, 6.889824e-03, -4.952303e-02, 4.706614e-01
-4507, 1.544099e-03, -4.997615e-02, 4.695887e-01
-4508, -3.284051e-02, -3.770279e-02, 4.739891e-01
-4509, -3.630741e-02, -3.437691e-02, 4.732179e-01
-4510, 3.982393e-02, -3.023334e-02, 3.189907e-02
-4511, 4.287921e-02, -2.571718e-02, 3.522430e-02
-4512, -4.509531e-02, 2.159661e-02, 4.743099e-01
-4513, -4.294605e-02, 2.560540e-02, 4.741910e-01
-4514, 4.233986e-02, 2.659580e-02, 4.613940e-01
-4515, 4.145910e-02, 2.794894e-02, 4.527033e-01
-4516, 3.944691e-02, 3.072363e-02, 1.185133e-01
-4517, 3.960786e-02, 3.051585e-02, 1.124285e-01
-4518, 4.412762e-02, 2.351071e-02, 4.696506e-01
-4519, 4.143207e-02, -2.798899e-02, 5.503702e-02
-4520, 4.142522e-02, -2.799912e-02, 6.097922e-02
-4521, 4.188208e-02, -2.731102e-02, 6.745280e-02
-4522, 4.172366e-02, -2.755242e-02, 7.357295e-02
-4523, 3.762840e-02, -3.292573e-02, 6.350434e-02
-4524, 4.061099e-02, -2.916758e-02, 7.983670e-02
-4525, 4.035930e-02, -2.951487e-02, 8.564946e-02
-4526, 3.687103e-02, -3.377169e-02, 7.624166e-02
-4527, 4.040830e-02, -2.944774e-02, 9.266325e-02
-4528, 4.074799e-02, -2.897588e-02, 9.832513e-02
-4529, 3.557662e-02, -3.513266e-02, 8.951920e-02
-4530, 4.208532e-02, -2.699677e-02, 1.050219e-01
-4531, 4.288970e-02, -2.569968e-02, 1.102528e-01
-4532, 3.726935e-02, -3.333160e-02, 1.032298e-01
-4533, 4.192160e-02, -2.725032e-02, 1.153631e-01
-4534, 4.010878e-02, -2.985441e-02, 1.217580e-01
-4535, 3.952751e-02, -3.061987e-02, 1.273702e-01
-4536, 3.674169e-02, -3.391236e-02, 1.163216e-01
-4537, 3.872362e-02, -3.163039e-02, 1.346187e-01
-4538, 3.917475e-02, -3.106991e-02, 1.403303e-01
-4539, 3.357109e-02, -3.705377e-02, 1.299651e-01
-4540, 4.126364e-02, -2.823671e-02, 1.464689e-01
-4541, 4.156065e-02, -2.779771e-02, 1.524431e-01
-4542, 3.518936e-02, -3.552055e-02, 1.433523e-01
-4543, 4.109640e-02, -2.847956e-02, 1.582207e-01
-4544, 4.111825e-02, -2.844801e-02, 1.638841e-01
-4545, 3.705245e-02, -3.357255e-02, 1.552685e-01
-4546, 4.163293e-02, -2.768933e-02, 1.696012e-01
-4547, 4.142819e-02, -2.799474e-02, 1.754948e-01
-4548, 3.711409e-02, -3.350439e-02, 1.667632e-01
-4549, 4.013554e-02, -2.981842e-02, 1.810193e-01
-4550, 3.961685e-02, -3.050418e-02, 1.867222e-01
-4551, 3.621762e-02, -3.447149e-02, 1.780048e-01
-4552, 3.910291e-02, -3.116027e-02, 1.934304e-01
-4553, 3.889727e-02, -3.141660e-02, 1.992705e-01
-4554, 3.403492e-02, -3.662819e-02, 1.902375e-01
-4555, 3.889403e-02, -3.142060e-02, 2.065007e-01
-4556, 3.912070e-02, -3.113794e-02, 2.122522e-01
-4557, 3.341585e-02, -3.719383e-02, 2.041759e-01
-4558, 4.004287e-02, -2.994276e-02, 2.199897e-01
-4559, 4.111900e-02, -2.844693e-02, 2.249846e-01
-4560, 3.451972e-02, -3.617166e-02, 2.191436e-01
-4561, 4.052291e-02, -2.928983e-02, 2.302890e-01
-4562, 4.094935e-02, -2.869060e-02, 2.388769e-01
-4563, 4.173883e-02, -2.752944e-02, 2.440443e-01
-4564, 3.610858e-02, -3.458570e-02, 2.354691e-01
-4565, 4.118632e-02, -2.834937e-02, 2.493008e-01
-4566, 4.173779e-02, -2.753102e-02, 2.567370e-01
-4567, 4.153827e-02, -2.783113e-02, 2.626938e-01
-4568, 3.727828e-02, -3.332161e-02, 2.514933e-01
-4569, 4.042791e-02, -2.942081e-02, 2.692945e-01
-4570, 4.018448e-02, -2.975244e-02, 2.751187e-01
-4571, 3.663689e-02, -3.402556e-02, 2.655303e-01
-4572, 4.013134e-02, -2.982407e-02, 2.822435e-01
-4573, 4.048825e-02, -2.933772e-02, 2.878587e-01
-4574, 3.522680e-02, -3.548342e-02, 2.792558e-01
-4575, 4.199556e-02, -2.713619e-02, 2.944363e-01
-4576, 4.284985e-02, -2.576608e-02, 2.995650e-01
-4577, 3.700952e-02, -3.361987e-02, 2.929583e-01
-4578, 4.198623e-02, -2.715062e-02, 3.047136e-01
-4579, 4.047940e-02, -2.934993e-02, 3.112747e-01
-4580, 4.008416e-02, -2.988745e-02, 3.169255e-01
-4581, 3.701094e-02, -3.361831e-02, 3.060969e-01
-4582, 4.016665e-02, -2.977651e-02, 3.241587e-01
-4583, 4.029067e-02, -2.960847e-02, 3.299935e-01
-4584, 3.526458e-02, -3.544586e-02, 3.198912e-01
-4585, 4.072790e-02, -2.900411e-02, 3.376164e-01
-4586, 4.151746e-02, -2.786217e-02, 3.429483e-01
-4587, 3.588586e-02, -3.481674e-02, 3.347473e-01
-4588, 4.049515e-02, -2.932820e-02, 3.481199e-01
-4589, 3.922848e-02, -3.100204e-02, 3.552901e-01
-4590, 3.886015e-02, -3.146249e-02, 3.611081e-01
-4591, 3.493048e-02, -3.577515e-02, 3.495403e-01
-4592, 3.880141e-02, -3.153491e-02, 3.680931e-01
-4593, 3.881801e-02, -3.151448e-02, 3.741127e-01
-4594, 3.332868e-02, -3.727197e-02, 3.636956e-01
-4595, 3.910873e-02, -3.115296e-02, 3.812211e-01
-4596, 3.933814e-02, -3.086277e-02, 3.871981e-01
-4597, 3.360407e-02, -3.702386e-02, 3.777891e-01
-4598, 3.969136e-02, -3.040717e-02, 3.942075e-01
-4599, 4.023166e-02, -2.968861e-02, 3.998592e-01
-4600, 3.436714e-02, -3.631666e-02, 3.919070e-01
-4601, 4.185254e-02, -2.735626e-02, 4.062818e-01
-4602, 4.275642e-02, -2.592081e-02, 4.114427e-01
-4603, 3.676696e-02, -3.388497e-02, 4.053389e-01
-4604, 4.187331e-02, -2.732446e-02, 4.167359e-01
-4605, 4.030893e-02, -2.958362e-02, 4.235614e-01
-4606, 3.985399e-02, -3.019370e-02, 4.293900e-01
-4607, 3.682950e-02, -3.381697e-02, 4.185869e-01
-4608, 3.969977e-02, -3.039619e-02, 4.367568e-01
-4609, 3.991890e-02, -3.010783e-02, 4.427774e-01
-4610, 3.473341e-02, -3.596651e-02, 4.327791e-01
-4611, 4.090701e-02, -2.875094e-02, 4.497528e-01
-4612, 4.144721e-02, -2.796656e-02, 4.557367e-01
-4613, 3.574357e-02, -3.496280e-02, 4.471213e-01
-4614, 4.260860e-02, -2.616308e-02, 4.622473e-01
-4615, 4.311142e-02, -2.532599e-02, 4.682694e-01
-4616, 3.831035e-02, -3.212969e-02, 4.606072e-01
-4617, 4.408468e-02, -2.359112e-02, 4.743794e-01
-4618, 4.111129e-02, 2.845807e-02, 1.329153e-01
-4619, 4.028495e-02, 2.961626e-02, 1.274790e-01
-4620, 3.378465e-02, 3.685916e-02, 2.735610e-02
-4621, 2.956866e-02, 4.031990e-02, 2.667793e-02
-4622, 2.507130e-02, 4.326003e-02, 2.463507e-02
-4623, 1.996460e-02, 4.584119e-02, 2.431189e-02
-4624, 2.748045e-02, 4.177110e-02, 3.169548e-02
-4625, 1.504509e-02, 4.768276e-02, 2.470259e-02
-4626, 9.649553e-03, 4.906003e-02, 2.553788e-02
-4627, 1.804698e-02, 4.662946e-02, 3.004332e-02
-4628, 4.815222e-03, 4.976760e-02, 2.841445e-02
-4629, -4.071539e-04, 4.999834e-02, 2.949541e-02
-4630, 8.282311e-03, 4.930926e-02, 3.331060e-02
-4631, -6.801622e-03, 4.953522e-02, 3.061551e-02
-4632, -1.205725e-02, 4.852446e-02, 3.060988e-02
-4633, -2.980971e-03, 4.991106e-02, 3.730727e-02
-4634, -1.891808e-02, 4.628289e-02, 2.891289e-02
-4635, -2.350683e-02, 4.412969e-02, 2.750679e-02
-4636, -1.631787e-02, 4.726232e-02, 3.673038e-02
-4637, -2.778398e-02, 4.156983e-02, 2.876948e-02
-4638, -3.394991e-02, 3.670699e-02, 2.918551e-02
-4639, -3.779486e-02, 3.273452e-02, 2.911577e-02
-4640, -2.962445e-02, 4.027893e-02, 3.544942e-02
-4641, -4.234511e-02, 2.658744e-02, 2.854415e-02
-4642, -4.482928e-02, 2.214353e-02, 2.722445e-02
-4643, -4.050934e-02, 2.930858e-02, 3.529382e-02
-4644, -4.676694e-02, 1.768767e-02, 2.849221e-02
-4645, -4.872760e-02, 1.120807e-02, 2.935283e-02
-4646, -4.965942e-02, 5.825982e-03, 2.951079e-02
-4647, -4.717565e-02, 1.656676e-02, 3.558282e-02
-4648, -4.999557e-02, -6.655612e-04, 2.907288e-02
-4649, -4.959893e-02, -6.320273e-03, 2.903310e-02
-4650, -4.987001e-02, 3.603048e-03, 3.600552e-02
-4651, -4.837305e-02, -1.265103e-02, 2.922636e-02
-4652, -4.667263e-02, -1.793504e-02, 2.910753e-02
-4653, -4.912804e-02, -9.297059e-03, 3.576086e-02
-4654, -4.408590e-02, -2.358883e-02, 2.959721e-02
-4655, -4.136509e-02, -2.808789e-02, 2.944646e-02
-4656, -4.522660e-02, -2.132028e-02, 3.644379e-02
-4657, -3.749228e-02, -3.308064e-02, 2.800808e-02
-4658, -3.412049e-02, -3.654849e-02, 2.664914e-02
-4659, -3.851761e-02, -3.188093e-02, 3.549509e-02
-4660, -3.040676e-02, -3.969167e-02, 2.760390e-02
-4661, -2.504165e-02, -4.327720e-02, 2.718899e-02
-4662, -1.999042e-02, -4.582994e-02, 2.784495e-02
-4663, -2.920563e-02, -4.058363e-02, 3.364179e-02
-4664, -1.445005e-02, -4.786644e-02, 3.049777e-02
-4665, -8.988806e-03, -4.918538e-02, 3.125112e-02
-4666, -1.838402e-02, -4.649761e-02, 3.587971e-02
-4667, -2.077957e-03, -4.995680e-02, 3.237952e-02
-4668, 3.600301e-03, -4.987021e-02, 3.234361e-02
-4669, -5.945951e-03, -4.964520e-02, 3.966093e-02
-4670, 1.065342e-02, -4.885187e-02, 3.094636e-02
-4671, 1.607891e-02, -4.734415e-02, 3.035725e-02
-4672, 8.095830e-03, -4.934022e-02, 3.939209e-02
-4673, 2.330026e-02, -4.423910e-02, 2.730686e-02
-4674, 2.738323e-02, -4.183490e-02, 2.517577e-02
-4675, 2.231619e-02, -4.474358e-02, 3.494445e-02
-4676, 4.045321e-02, 2.938601e-02, 1.385864e-01
-4677, -4.976918e-02, 4.798802e-03, 4.682998e-01
-4678, -4.891706e-02, 1.034994e-02, 4.689100e-01
-4679, 4.055380e-02, 2.924704e-02, 2.917556e-01
-4680, 4.148406e-02, 2.791187e-02, 2.851993e-01
-4681, 4.093464e-02, 2.871159e-02, 3.743613e-01
-4682, 4.116686e-02, 2.837763e-02, 3.663329e-01
-4683, 3.842925e-02, 3.198738e-02, 2.447301e-01
-4684, 3.869504e-02, 3.166534e-02, 2.384456e-01
-4685, 4.143502e-02, 2.798462e-02, 2.594422e-01
-4686, 4.026700e-02, 2.964066e-02, 2.528517e-01
-4687, 3.875103e-02, 3.159680e-02, 2.653847e-01
-4688, 4.075402e-02, 2.896739e-02, 4.237235e-01
-4689, 4.071860e-02, 2.901717e-02, 4.140377e-01
-4690, 4.181928e-02, 2.740708e-02, 2.181469e-01
-4691, 4.190327e-02, 2.727849e-02, 2.106620e-01
-4692, 4.033029e-02, 2.955449e-02, 3.210763e-01
-4693, 3.985080e-02, 3.019790e-02, 3.145654e-01
-4694, 4.250228e-02, 2.633545e-02, 3.350060e-01
-4695, 4.155072e-02, 2.781254e-02, 3.282436e-01
-4696, 3.987897e-02, 3.016070e-02, 3.404248e-01
-4697, 4.076689e-02, 2.894928e-02, 4.419761e-01
-4698, 4.097472e-02, 2.865436e-02, 4.328103e-01
-4699, 3.663942e-02, 3.402283e-02, 4.488291e-01
-4700, 3.892959e-02, 3.137654e-02, 3.066360e-01
-4701, 3.916443e-02, 3.108291e-02, 2.998475e-01
-4702, 3.439615e-02, 3.628919e-02, 2.946133e-01
-4703, 3.380631e-02, 3.683929e-02, 3.106345e-01
-4704, 4.043988e-02, 2.940435e-02, 4.050625e-01
-4705, 3.978311e-02, 3.028703e-02, 3.971828e-01
-4706, 3.492213e-02, 3.578331e-02, 4.109531e-01
-4707, 3.958263e-02, 3.054857e-02, 3.889863e-01
-4708, 3.990228e-02, 3.012985e-02, 3.816598e-01
-4709, 3.536182e-02, 3.534886e-02, 3.782865e-01
-4710, 3.434034e-02, 3.634200e-02, 3.937815e-01
-4711, -4.019543e-02, -2.973764e-02, 4.737570e-01
-4712, -4.319891e-02, -2.517646e-02, 4.733004e-01
-4713, -3.729655e-02, -3.330116e-02, 4.675597e-01
-4714, 4.470894e-02, 2.238551e-02, 2.578016e-02
-4715, 2.150289e-02, 4.514007e-02, 4.726467e-01
-4716, 2.587089e-02, 4.278665e-02, 4.738441e-01
-4717, 4.105607e-02, 2.853768e-02, 2.313107e-01
-4718, 4.142220e-02, 2.800360e-02, 2.244675e-01
-4719, 3.745247e-02, 3.312570e-02, 2.214209e-01
-4720, 3.422431e-02, 3.645129e-02, 2.348764e-01
-4721, -4.582839e-02, -1.999397e-02, 4.708954e-01
-4722, -4.771646e-02, -1.493784e-02, 4.699216e-01
-4723, -4.408281e-02, -2.359461e-02, 4.656938e-01
-4724, -4.686711e-02, 1.742050e-02, 4.722873e-01
-4725, -4.714581e-02, 1.665150e-02, 4.641657e-01
-4726, 3.972152e-02, 3.036776e-02, 4.678128e-01
-4727, 4.083329e-02, -2.885555e-02, 4.732278e-01
-4728, 4.127879e-02, 2.821455e-02, 1.675528e-01
-4729, 4.092882e-02, 2.871988e-02, 1.613289e-01
-4730, 3.771703e-02, 3.282416e-02, 1.723081e-01
-4731, 4.001476e-02, 2.998031e-02, 1.535580e-01
-4732, 4.000413e-02, 2.999450e-02, 1.472695e-01
-4733, 3.557166e-02, 3.513769e-02, 1.577206e-01
-4734, 1.281908e-02, -4.832878e-02, 4.736974e-01
-4735, 1.229178e-02, -4.846558e-02, 4.659319e-01
-4736, 1.746850e-02, -4.684924e-02, 4.752290e-01
-4737, 4.391269e-02, 2.390973e-02, 3.227346e-02
-4738, 4.165803e-02, 2.765155e-02, 2.708960e-02
-4739, 3.829374e-02, 3.214949e-02, 2.727839e-02
-4740, 4.325377e-02, 2.508209e-02, 3.821315e-02
-4741, -1.324661e-02, 4.821335e-02, 4.669928e-01
-4742, -7.574306e-03, 4.942297e-02, 4.679057e-01
-4743, -2.904321e-02, -4.070003e-02, 4.723048e-01
-4744, 3.553245e-02, 3.517733e-02, 4.290151e-01
-4745, 3.524576e-02, -3.546458e-02, 2.758403e-02
-4746, 3.441608e-02, -3.627029e-02, 3.620911e-02
-4747, -1.816659e-02, -4.658299e-02, 4.689917e-01
-4748, -2.315971e-02, -4.431284e-02, 4.696716e-01
-4749, 3.655412e-02, 3.411446e-02, 3.366062e-02
-4750, 3.728747e-02, -3.331133e-02, 4.730107e-01
-4751, -5.422490e-03, -4.970510e-02, 4.682952e-01
-4752, -1.118053e-02, -4.873393e-02, 4.682693e-01
-4753, -6.104468e-04, -4.999627e-02, 4.616025e-01
-4754, -1.894422e-03, 4.996410e-02, 4.705104e-01
-4755, 3.841285e-03, 4.985223e-02, 4.709957e-01
-4756, -4.094747e-03, 4.983205e-02, 4.620637e-01
-4757, 4.096330e-02, 2.867068e-02, 5.167320e-02
-4758, 4.131950e-02, 2.815491e-02, 4.559061e-02
-4759, 1.017570e-02, 4.895360e-02, 4.704512e-01
-4760, 1.546710e-02, 4.754754e-02, 4.708141e-01
-4761, 2.031182e-02, 4.568840e-02, 4.654120e-01
-4762, 7.977337e-03, 4.935952e-02, 4.641239e-01
-4763, 4.229148e-02, -2.667266e-02, 4.678371e-02
-4764, 3.811553e-02, -3.236057e-02, 4.877745e-02
-4765, 3.500437e-02, 3.570286e-02, 1.412666e-01
-4766, 4.246184e-02, 2.640061e-02, 9.279836e-02
-4767, 4.145541e-02, 2.795442e-02, 8.780147e-02
-4768, 3.981722e-02, 3.024217e-02, 3.599504e-01
-4769, 3.785355e-02, 3.266663e-02, 3.530870e-01
-4770, 3.497252e-02, 3.573406e-02, 3.646055e-01
-4771, -4.048493e-02, 2.934230e-02, 4.719860e-01
-4772, 3.846577e-02, 3.194346e-02, 4.096036e-02
-4773, -4.993055e-02, -2.634342e-03, 4.681382e-01
-4774, -4.995311e-02, 2.164915e-03, 4.606269e-01
-4775, -4.929120e-02, -8.389151e-03, 4.685098e-01
-4776, 3.454994e-02, 3.614280e-02, 1.236177e-01
-4777, 4.032971e-02, 2.955528e-02, 7.886481e-02
-4778, 4.045994e-02, 2.937674e-02, 7.269541e-02
-4779, 3.631348e-02, 3.437050e-02, 8.636436e-02
-4780, 3.574468e-02, 3.496166e-02, 4.685393e-01
-4781, 3.015154e-02, 3.988590e-02, 4.723835e-01
-4782, 3.211764e-02, 3.832046e-02, 4.634004e-01
-4783, 3.890737e-02, 3.140409e-02, 2.795181e-01
-4784, 4.004422e-02, 2.994095e-02, 2.052100e-01
-4785, 3.802060e-02, 3.247205e-02, 1.988970e-01
-4786, 3.572822e-02, 3.497848e-02, 2.096483e-01
-4787, -4.856294e-02, -1.190129e-02, 4.618771e-01
-4788, 3.353402e-02, 3.708732e-02, 2.501329e-01
-4789, 3.638470e-02, 3.429510e-02, 3.257312e-01
-4790, -3.576862e-02, 3.493717e-02, 4.681214e-01
-4791, -3.160252e-02, 3.874637e-02, 4.671047e-01
-4792, -4.030204e-02, 2.959300e-02, 4.636785e-01
-4793, 4.313160e-02, -2.529161e-02, 4.129030e-02
-4794, -1.468446e-02, -4.779505e-02, 4.610316e-01
-4795, -2.750994e-02, -4.175169e-02, 4.643873e-01
-4796, -4.996178e-02, -1.954712e-03, 4.509924e-01
-4797, -4.969928e-02, 5.475548e-03, 4.511540e-01
-4798, 4.249211e-02, 2.635186e-02, 9.750524e-02
-4799, -2.575096e-02, -4.285893e-02, 4.535247e-01
-4800, -3.140947e-02, -3.890302e-02, 4.561580e-01
-4801, 3.219997e-02, -3.825130e-02, 4.724544e-01
-4802, 2.780698e-02, -4.155444e-02, 4.726867e-01
-4803, 3.398203e-02, 3.667726e-02, 4.103807e-02
-4804, 2.817548e-02, 4.130548e-02, 4.344848e-01
-4805, 2.785826e-02, 4.152009e-02, 4.253980e-01
-4806, 2.664970e-02, 4.230595e-02, 1.463887e-01
-4807, 2.728652e-02, 4.189804e-02, 1.377056e-01
-4808, 2.863341e-02, -4.098937e-02, 8.588943e-02
-4809, 2.870150e-02, -4.094171e-02, 9.290323e-02
-4810, 2.913845e-02, -4.063189e-02, 1.020807e-01
-4811, 3.104569e-02, -3.919394e-02, 1.087775e-01
-4812, 2.130656e-02, -4.523307e-02, 9.845096e-02
-4813, 2.657032e-02, -4.235585e-02, 1.243680e-01
-4814, 2.546769e-02, -4.302786e-02, 1.316165e-01
-4815, 1.939774e-02, -4.608392e-02, 1.473978e-01
-4816, 2.868194e-02, -4.095542e-02, 1.452832e-01
-4817, 2.387335e-02, -4.393248e-02, 1.393282e-01
-4818, 1.581866e-02, -4.743174e-02, 1.337311e-01
-4819, 3.074014e-02, -3.943404e-02, 1.714375e-01
-4820, 2.894689e-02, -4.076858e-02, 1.769620e-01
-4821, 2.524161e-02, -4.316088e-02, 2.172525e-01
-4822, 2.653306e-02, -4.237920e-02, 2.249900e-01
-4823, 3.076556e-02, -3.941422e-02, 2.517172e-01
-4824, 3.153742e-02, -3.879937e-02, 2.591535e-01
-4825, 2.857062e-02, -4.103315e-02, 2.924172e-01
-4826, 3.071877e-02, -3.945069e-02, 2.989947e-01
-4827, 2.942720e-02, -4.042326e-02, 3.300504e-01
-4828, 3.002698e-02, -3.997975e-02, 3.376733e-01
-4829, 2.423615e-02, -4.373338e-02, 3.600144e-01
-4830, 2.415455e-02, -4.377851e-02, 3.669995e-01
-4831, 2.648002e-02, -4.241236e-02, 3.746365e-01
-4832, 2.687240e-02, -4.216485e-02, 3.817450e-01
-4833, 1.641831e-02, -4.722752e-02, 3.709554e-01
-4834, 3.067732e-02, -3.948293e-02, 4.123916e-01
-4835, 2.846189e-02, -4.110865e-02, 4.192171e-01
-4836, 2.741340e-02, -4.181514e-02, 4.288234e-01
-4837, 2.720017e-02, -4.195415e-02, 4.361902e-01
-4838, 2.005974e-02, -4.579964e-02, 4.226281e-01
-4839, 2.819870e-02, -4.128963e-02, 4.460395e-01
-4840, 2.956874e-02, -4.031984e-02, 4.530148e-01
-4841, 2.000029e-02, -4.582563e-02, 4.420837e-01
-4842, 2.543711e-02, -4.304595e-02, 4.589691e-01
-4843, 3.337972e-02, -3.722625e-02, 4.600509e-01
-4844, 2.751831e-02, 4.174617e-02, 4.156492e-01
-4845, 2.711875e-02, 4.200683e-02, 4.066740e-01
-4846, 1.905614e-02, 4.622622e-02, 4.211188e-01
-4847, 3.131514e-02, -3.897899e-02, 2.541986e-02
-4848, -2.536861e-02, 4.308635e-02, 4.661438e-01
-4849, -2.008923e-02, 4.578671e-02, 4.662093e-01
-4850, 4.134834e-02, 2.811254e-02, 6.508318e-02
-4851, 4.139448e-02, 2.804455e-02, 5.860591e-02
-4852, 2.659114e-02, 4.234278e-02, 2.573416e-01
-4853, 2.402081e-02, 4.385203e-02, 2.492200e-01
-4854, 4.132326e-02, 2.814939e-02, 1.027531e-01
-4855, 3.564267e-02, 3.506565e-02, 1.049765e-01
-4856, 3.285015e-02, -3.769440e-02, 4.513363e-02
-4857, 3.164892e-02, -3.870848e-02, 5.338694e-02
-4858, 2.730456e-02, -4.188629e-02, 4.081859e-02
-4859, 3.584847e-02, 3.485523e-02, 3.457858e-01
-4860, 3.347998e-02, 3.713612e-02, 3.382595e-01
-4861, 3.101857e-02, 3.921541e-02, 3.509218e-01
-4862, -2.981511e-02, 4.013800e-02, 4.588530e-01
-4863, 3.119136e-02, 3.907811e-02, 4.549684e-01
-4864, 3.023144e-02, 3.982537e-02, 4.442413e-01
-4865, 2.503698e-02, 4.327990e-02, 4.588126e-01
-4866, 3.388755e-02, 3.676457e-02, 2.730815e-01
-4867, 3.036668e-02, 3.972234e-02, 2.659514e-01
-4868, 2.032882e-02, 4.568084e-02, 2.650384e-01
-4869, 3.056345e-02, 3.957114e-02, 2.800848e-01
-4870, 3.067062e-02, 3.948814e-02, 3.306759e-01
-4871, 2.896348e-02, 4.075680e-02, 3.235086e-01
-4872, 2.555860e-02, 4.297392e-02, 3.360370e-01
-4873, 3.631626e-02, 3.436756e-02, 1.922107e-01
-4874, 3.436794e-02, 3.631590e-02, 1.849742e-01
-4875, 3.144189e-02, 3.887682e-02, 1.975100e-01
-4876, 3.602906e-02, 3.466853e-02, 6.981547e-02
-4877, 2.400102e-02, -4.386287e-02, 4.674866e-01
-4878, 2.212918e-02, -4.483636e-02, 4.741680e-01
-4879, -1.674467e-02, 4.711280e-02, 4.586756e-01
-4880, -3.377243e-02, 3.687035e-02, 4.498515e-01
-4881, -2.779766e-02, 4.156068e-02, 4.488905e-01
-4882, 3.656886e-02, 3.409865e-02, 5.527053e-02
-4883, 2.636069e-02, 4.248663e-02, 1.285309e-01
-4884, 2.517059e-02, 4.320233e-02, 1.195651e-01
-4885, 1.676546e-02, 4.710541e-02, 1.336530e-01
-4886, 3.122152e-02, -3.905402e-02, 6.300972e-02
-4887, 3.186238e-02, -3.853296e-02, 6.948330e-02
-4888, 2.503307e-02, -4.328216e-02, 5.936590e-02
-4889, -1.882631e-02, 4.632030e-02, 4.489542e-01
-4890, -1.191973e-02, 4.855842e-02, 4.497377e-01
-4891, -2.347524e-02, 4.414650e-02, 4.399527e-01
-4892, -4.879449e-02, -1.091321e-02, 4.522378e-01
-4893, -4.941121e-02, -7.650642e-03, 4.427649e-01
-4894, -4.688502e-02, -1.737225e-02, 4.536495e-01
-4895, -1.086010e-02, -4.880633e-02, 4.509894e-01
-4896, -1.786014e-02, -4.670134e-02, 4.517119e-01
-4897, 2.849435e-02, 4.108616e-02, 4.710769e-02
-4898, 2.607066e-02, 4.266521e-02, 3.980795e-02
-4899, 2.304169e-02, 4.437432e-02, 2.977062e-01
-4900, 2.506001e-02, 4.326657e-02, 2.896143e-01
-4901, 2.174140e-02, 4.502567e-02, 4.406242e-01
-4902, 5.186723e-03, -4.973025e-02, 4.533085e-01
-4903, -1.781073e-03, -4.996827e-02, 4.520151e-01
-4904, -5.131769e-03, -4.973595e-02, 4.426954e-01
-4905, 1.958448e-02, -4.600487e-02, 4.604504e-01
-4906, 1.388633e-02, -4.803301e-02, 4.574145e-01
-4907, -2.645376e-03, 4.992997e-02, 4.525304e-01
-4908, 3.060178e-03, 4.990627e-02, 4.551350e-01
-4909, -4.866477e-03, 4.976261e-02, 4.428090e-01
-4910, 1.655685e-02, 4.717913e-02, 1.146565e-01
-4911, 2.592346e-02, 4.275481e-02, 1.097432e-01
-4912, 2.832177e-02, 4.120531e-02, 3.718870e-01
-4913, 2.639537e-02, 4.246509e-02, 3.655044e-01
-4914, 3.256042e-02, 3.794495e-02, 1.772925e-01
-4915, 3.133077e-02, 3.896643e-02, 1.704760e-01
-4916, 2.741792e-02, 4.181217e-02, 1.831421e-01
-4917, 3.032665e-02, -3.975292e-02, 7.574705e-02
-4918, 2.270825e-02, -4.454588e-02, 7.913107e-02
-4919, 2.849723e-02, -4.108416e-02, 1.151725e-01
-4920, 1.968928e-02, -4.596012e-02, 1.168239e-01
-4921, 3.149235e-02, -3.883596e-02, 1.514218e-01
-4922, 3.084737e-02, -3.935022e-02, 1.571994e-01
-4923, 3.001195e-02, -3.999103e-02, 1.657204e-01
-4924, 2.355445e-02, -4.410428e-02, 1.618737e-01
-4925, 2.709965e-02, -4.201915e-02, 1.856011e-01
-4926, 2.639552e-02, -4.246500e-02, 1.923093e-01
-4927, 2.060913e-02, -4.555506e-02, 1.790338e-01
-4928, 2.565348e-02, -4.291735e-02, 2.010012e-01
-4929, 2.564906e-02, -4.291999e-02, 2.082314e-01
-4930, 1.774694e-02, -4.674448e-02, 1.963649e-01
-4931, 2.612460e-02, -4.263221e-02, 2.347904e-01
-4932, 2.674886e-02, -4.224333e-02, 2.433783e-01
-4933, 1.558229e-02, -4.750992e-02, 2.328993e-01
-4934, 3.000930e-02, -3.999302e-02, 2.657542e-01
-4935, 2.794547e-02, -4.146144e-02, 2.753644e-01
-4936, 2.787147e-02, -4.151122e-02, 2.824893e-01
-4937, 2.189453e-02, -4.495141e-02, 2.689876e-01
-4938, 2.857235e-02, -4.103195e-02, 3.055558e-01
-4939, 2.762634e-02, -4.167476e-02, 3.148150e-01
-4940, 2.774146e-02, -4.159821e-02, 3.220482e-01
-4941, 2.009502e-02, -4.578417e-02, 3.077128e-01
-4942, 1.981371e-02, -4.590661e-02, 3.399125e-01
-4943, 2.734751e-02, -4.185826e-02, 3.446094e-01
-4944, 2.556652e-02, -4.296921e-02, 3.517796e-01
-4945, 2.653912e-02, -4.237541e-02, 3.895906e-01
-4946, 2.702592e-02, -4.206661e-02, 3.966000e-01
-4947, 1.857559e-02, -4.642141e-02, 3.864380e-01
-4948, 2.838588e-02, -4.116117e-02, 4.059691e-01
-4949, 2.134183e-02, 4.521644e-02, 3.776509e-02
-4950, 1.648026e-02, 4.720594e-02, 3.815579e-02
-4951, 1.179428e-02, 4.858904e-02, 4.103237e-02
-4952, 3.479952e-03, 4.987875e-02, 4.500819e-02
-4953, -2.931169e-03, 4.991401e-02, 4.612828e-02
-4954, 1.184276e-02, 4.857725e-02, 4.985338e-02
-4955, -1.191815e-02, 4.855881e-02, 4.783857e-02
-4956, -1.878538e-02, 4.633691e-02, 4.614158e-02
-4957, -5.556984e-03, 4.969024e-02, 5.553949e-02
-4958, -2.559903e-02, 4.294985e-02, 4.257125e-02
-4959, -3.200798e-02, 3.841210e-02, 4.298728e-02
-4960, -2.155544e-02, 4.511500e-02, 5.367944e-02
-4961, -3.750778e-02, 3.306307e-02, 4.420392e-02
-4962, -4.211149e-02, 2.695593e-02, 4.363230e-02
-4963, -3.414193e-02, 3.652846e-02, 5.132575e-02
-4964, -4.570143e-02, 2.028249e-02, 4.413954e-02
-4965, -4.802238e-02, 1.392305e-02, 4.500015e-02
-4966, -4.354260e-02, 2.457726e-02, 5.304963e-02
-4967, -4.951611e-02, 6.939404e-03, 4.477540e-02
-4968, -4.999791e-02, 4.570437e-04, 4.433748e-02
-4969, -4.880349e-02, 1.087287e-02, 5.333211e-02
-4970, -4.963240e-02, -6.051877e-03, 4.270350e-02
-4971, -4.844077e-02, -1.238917e-02, 4.289675e-02
-4972, -4.992652e-02, -2.709720e-03, 5.147337e-02
-4973, -4.645695e-02, -1.848652e-02, 4.536738e-02
-4974, -4.380345e-02, -2.410929e-02, 4.585706e-02
-4975, -4.757033e-02, -1.539687e-02, 5.231002e-02
-4976, -3.977056e-02, -3.030350e-02, 4.579795e-02
-4977, -3.563105e-02, -3.507746e-02, 4.435957e-02
-4978, -4.156611e-02, -2.778954e-02, 5.472154e-02
-4979, -2.983274e-02, -4.012490e-02, 4.177288e-02
-4980, -2.441662e-02, -4.363289e-02, 4.135797e-02
-4981, -3.142483e-02, -3.889062e-02, 5.207575e-02
-4982, -1.910433e-02, -4.620632e-02, 4.401080e-02
-4983, -1.190073e-02, -4.856308e-02, 4.761952e-02
-4984, -5.048061e-03, -4.974452e-02, 4.874792e-02
-4985, -1.826642e-02, -4.654393e-02, 5.309778e-02
-4986, 4.442894e-03, -4.980222e-02, 4.967421e-02
-4987, 1.147778e-02, -4.866478e-02, 4.827696e-02
-4988, -1.606971e-03, -4.997417e-02, 5.763279e-02
-4989, 1.698789e-02, -4.702565e-02, 5.415110e-02
-4990, 2.040248e-02, -4.564799e-02, 4.386898e-02
-4991, 3.009722e-02, 3.992690e-02, 6.310912e-02
-4992, 2.948668e-02, 4.037989e-02, 5.617641e-02
-4993, 2.093271e-02, 4.540729e-02, 5.494628e-02
-4994, 2.884915e-02, 4.083781e-02, 7.072135e-02
-4995, 1.101755e-02, 4.877103e-02, 2.469993e-01
-4996, 1.931185e-02, 4.611998e-02, 2.397907e-01
-4997, 2.925402e-02, 4.054877e-02, 9.026236e-02
-4998, 2.764481e-02, 4.166251e-02, 8.132570e-02
-4999, 3.048737e-02, 3.962979e-02, 2.185572e-01
-5000, 2.785067e-02, 4.152518e-02, 2.131052e-01
-5001, 1.401275e-02, 4.799628e-02, 2.297921e-01
-5002, 2.668689e-02, 4.228250e-02, 2.320128e-01
-5003, -2.228218e-02, -4.476052e-02, 4.434826e-01
-5004, 1.921259e-02, 4.616142e-02, 4.569800e-01
-5005, 1.845192e-02, 4.647071e-02, 2.831777e-01
-5006, 2.584000e-02, 4.280531e-02, 3.155615e-01
-5007, 2.454790e-02, 4.355916e-02, 3.076321e-01
-5008, 1.379621e-02, 4.805897e-02, 3.026332e-01
-5009, 1.894138e-02, 4.627336e-02, 3.205062e-01
-5010, 2.685891e-02, 4.217344e-02, 3.791854e-01
-5011, -4.067634e-02, -2.907638e-02, 4.598756e-01
-5012, -4.377536e-02, -2.416024e-02, 4.574706e-01
-5013, -4.425670e-02, -2.326681e-02, 4.478313e-01
-5014, -3.686469e-02, -3.377861e-02, 4.593365e-01
-5015, 2.693822e-02, 4.212283e-02, 3.968792e-01
-5016, 2.666000e-02, 4.229946e-02, 3.886827e-01
-5017, 1.849824e-02, 4.645229e-02, 3.822832e-01
-5018, 1.847884e-02, 4.646001e-02, 4.015752e-01
-5019, -4.739139e-02, 1.593915e-02, 4.524852e-01
-5020, -4.453728e-02, 2.272511e-02, 4.558625e-01
-5021, -4.854268e-02, 1.198366e-02, 4.428507e-01
-5022, 2.071300e-02, 4.550793e-02, 7.461935e-02
-5023, 2.837737e-02, 4.116704e-02, 1.000678e-01
-5024, 1.838249e-02, 4.649822e-02, 9.502912e-02
-5025, -3.542899e-02, -3.528154e-02, 4.484739e-01
-5026, 2.908778e-02, 4.066818e-02, 1.628263e-01
-5027, 2.780744e-02, 4.155414e-02, 1.550553e-01
-5028, 1.907808e-02, 4.621717e-02, 1.514943e-01
-5029, 2.288524e-02, 4.445521e-02, 1.678107e-01
-5030, 1.531534e-02, -4.759664e-02, 3.550835e-01
-5031, 1.455649e-02, 4.783418e-02, 4.479911e-01
-5032, 1.211501e-02, 4.851007e-02, 4.382347e-01
-5033, 1.275771e-02, -4.834502e-02, 4.478270e-01
-5034, 1.972070e-02, -4.594664e-02, 4.036527e-01
-5035, -3.996303e-02, -3.004923e-02, 4.416900e-01
-5036, -4.399212e-02, -2.376327e-02, 4.378689e-01
-5037, -3.502979e-02, -3.567792e-02, 4.385115e-01
-5038, 4.145355e-03, 4.982786e-02, 1.206691e-01
-5039, 5.017506e-03, 4.974761e-02, 1.108472e-01
-5040, 2.991629e-02, 4.006265e-02, 2.248778e-01
-5041, 2.036642e-02, -4.566409e-02, 2.885258e-01
-5042, 1.972919e-02, -4.594300e-02, 2.510385e-01
-5043, 2.092600e-02, -4.541038e-02, 3.249742e-01
-5044, 3.494571e-02, -3.576028e-02, 4.665615e-01
-5045, -4.074341e-02, 2.898231e-02, 4.519979e-01
-5046, -3.926326e-02, 3.095798e-02, 4.420355e-01
-5047, 2.825700e-03, 4.992009e-02, 6.336298e-02
-5048, 1.302251e-02, 4.827437e-02, 5.892210e-02
-5049, 1.234013e-02, 4.845329e-02, 6.845588e-02
-5050, 1.092053e-02, 4.879285e-02, 7.906023e-02
-5051, 8.109086e-03, 4.933805e-02, 9.946901e-02
-5052, 9.165696e-03, 4.915272e-02, 8.966358e-02
-5053, 3.303046e-04, 4.999891e-02, 8.350011e-02
-5054, -4.573836e-03, 4.979036e-02, 1.054816e-01
-5055, 1.276153e-02, 4.834401e-02, 2.738237e-01
-5056, 8.268725e-03, 4.931154e-02, 2.652140e-01
-5057, 6.253999e-03, 4.960733e-02, 2.833533e-01
-5058, 1.648570e-02, -4.720404e-02, 2.140779e-01
-5059, 2.589122e-02, 4.277435e-02, 3.572033e-01
-5060, 2.330744e-02, 4.423532e-02, 3.499022e-01
-5061, 1.816705e-02, 4.658281e-02, 3.644848e-01
-5062, -8.750798e-04, 4.999234e-02, 2.275057e-01
-5063, 7.420664e-03, 4.944627e-02, 2.197278e-01
-5064, 2.452648e-02, 4.357122e-02, 2.045517e-01
-5065, 2.227401e-02, 4.476459e-02, 1.978655e-01
-5066, 1.819437e-02, 4.657215e-02, 2.134606e-01
-5067, 5.134328e-03, 4.973569e-02, 2.556559e-01
-5068, -8.564203e-05, 4.999993e-02, 2.462265e-01
-5069, -2.885867e-03, 4.991665e-02, 2.644412e-01
-5070, -4.323175e-02, 2.512002e-02, 4.328269e-01
-5071, -3.701427e-02, 3.361464e-02, 4.306804e-01
-5072, 1.646996e-02, -4.720954e-02, 6.377388e-02
-5073, 1.666314e-02, -4.714170e-02, 7.355910e-02
-5074, 8.067512e-03, -4.934486e-02, 6.834430e-02
-5075, 1.003090e-02, -4.898348e-02, 4.179439e-01
-5076, 8.789190e-03, -4.922144e-02, 4.275502e-01
-5077, 1.031298e-02, 4.892486e-02, 1.587006e-01
-5078, 8.958427e-03, 4.919092e-02, 1.500339e-01
-5079, -8.228940e-03, 4.931820e-02, 4.307020e-01
-5080, 1.122368e-03, 4.998740e-02, 4.334946e-01
-5081, 1.060888e-02, 4.886156e-02, 4.060332e-01
-5082, 1.039909e-02, 4.890664e-02, 3.962384e-01
-5083, 3.253861e-03, 4.989401e-02, 3.119509e-01
-5084, 1.543186e-03, 4.997618e-02, 3.020250e-01
-5085, -2.727252e-02, -4.190716e-02, 4.346992e-01
-5086, -3.280000e-02, -3.773804e-02, 4.279152e-01
-5087, -1.952469e-02, -4.603028e-02, 4.328863e-01
-5088, 6.461498e-03, 4.958073e-02, 1.311780e-01
-5089, -5.359519e-03, 4.971193e-02, 1.273687e-01
-5090, 7.547757e-03, 4.942703e-02, 1.403527e-01
-5091, 4.457299e-03, -4.980093e-02, 3.491522e-01
-5092, 2.927272e-03, -4.991424e-02, 3.573871e-01
-5093, 1.004857e-02, -4.897986e-02, 9.277926e-02
-5094, 1.057270e-02, -4.886940e-02, 1.019568e-01
-5095, 9.094406e-03, -4.916596e-02, 2.824079e-01
-5096, 9.925917e-03, -4.900486e-02, 2.923358e-01
-5097, 1.105602e-02, -4.876233e-02, 3.236947e-01
-5098, 1.305020e-02, -4.826689e-02, 3.316969e-01
-5099, 8.798395e-03, 4.921980e-02, 4.261276e-01
-5100, 8.396216e-03, 4.928999e-02, 4.163788e-01
-5101, -1.593701e-05, 5.000000e-02, 4.110419e-01
-5102, -2.708992e-03, 4.992656e-02, 2.918751e-01
-5103, -8.660815e-03, 4.924419e-02, 2.825211e-01
-5104, -1.327074e-02, 4.820671e-02, 3.011928e-01
-5105, -4.461688e-02, -2.256842e-02, 4.274431e-01
-5106, -4.765345e-02, -1.513767e-02, 4.335845e-01
-5107, 2.042003e-02, 4.564014e-02, 3.429569e-01
-5108, 1.702300e-02, 4.701295e-02, 3.353732e-01
-5109, 1.457483e-02, 4.782859e-02, 3.492384e-01
-5110, -4.959954e-02, -6.315531e-03, 4.323391e-01
-5111, -6.257486e-03, 4.960689e-02, 6.507327e-02
-5112, -2.637483e-02, -4.247786e-02, 5.942213e-02
-5113, -1.965126e-02, -4.597639e-02, 6.303085e-02
-5114, -1.075123e-02, -4.883043e-02, 6.672833e-02
-5115, -1.330251e-03, -4.998230e-02, 6.765463e-02
-5116, -1.939640e-02, -4.608449e-02, 7.305268e-02
-5117, 1.159182e-03, -4.998656e-02, 4.332935e-01
-5118, -7.972444e-03, -4.936031e-02, 4.322678e-01
-5119, 9.561416e-03, -4.907728e-02, 2.538114e-01
-5120, 1.433178e-02, -4.790198e-02, 2.621503e-01
-5121, -1.609717e-03, 4.997408e-02, 1.475589e-01
-5122, -1.125570e-03, -4.998733e-02, 7.743984e-02
-5123, -7.666544e-03, 4.940875e-02, 7.651522e-02
-5124, -1.581620e-02, 4.743256e-02, 6.869173e-02
-5125, -9.431511e-03, 4.910241e-02, 8.711858e-02
-5126, -7.560712e-03, 4.942505e-02, 2.387540e-01
-5127, -1.414866e-02, 4.795639e-02, 2.286898e-01
-5128, -1.338971e-02, 4.817381e-02, 2.474106e-01
-5129, 6.682601e-03, -4.955142e-02, 2.092069e-01
-5130, 6.213223e-03, -4.961246e-02, 2.182280e-01
-5131, 1.084745e-02, 4.880915e-02, 3.293594e-01
-5132, 7.173383e-03, 4.948275e-02, 3.214123e-01
-5133, -5.226337e-03, 4.972610e-02, 3.208040e-01
-5134, 5.133008e-03, 4.973582e-02, 3.362793e-01
-5135, 7.970608e-03, 4.936061e-02, 3.860387e-01
-5136, 8.202978e-03, 4.932252e-02, 3.765414e-01
-5137, -2.327750e-04, 4.999946e-02, 3.904967e-01
-5138, 1.159439e-02, -4.863713e-02, 4.379777e-01
-5139, 3.540826e-03, 4.987447e-02, 2.111743e-01
-5140, 1.068446e-02, -4.884508e-02, 3.986781e-01
-5141, 1.227462e-02, -4.846993e-02, 4.080472e-01
-5142, 9.407886e-03, 4.910694e-02, 4.545905e-01
-5143, 2.197487e-02, 4.491219e-02, 1.894455e-01
-5144, 1.976379e-02, 4.592812e-02, 1.817639e-01
-5145, 1.418636e-02, 4.794525e-02, 1.964872e-01
-5146, 9.865017e-03, -4.901715e-02, 3.386330e-01
-5147, -2.705113e-03, -4.992677e-02, 3.409366e-01
-5148, 4.645622e-03, -4.978371e-02, 3.719341e-01
-5149, 7.323289e-03, -4.946079e-02, 3.795712e-01
-5150, 5.954153e-04, -4.999645e-02, 4.129693e-01
-5151, 4.993799e-04, -4.999751e-02, 1.058173e-01
-5152, 1.226603e-02, -4.847210e-02, 1.114890e-01
-5153, 6.332438e-03, -4.959738e-02, 1.301547e-01
-5154, 4.510152e-03, -4.979617e-02, 1.378664e-01
-5155, -1.927473e-03, -4.996283e-02, 2.972560e-01
-5156, 9.838463e-03, -4.902249e-02, 3.033738e-01
-5157, 8.580303e-03, -4.925828e-02, 1.491802e-01
-5158, 1.408816e-02, -4.797420e-02, 1.551352e-01
-5159, 8.714584e-03, -4.923470e-02, 3.126330e-01
-5160, 3.716687e-04, -4.999862e-02, 3.193557e-01
-5161, 1.307486e-02, -4.826021e-02, 1.636562e-01
-5162, 1.286000e-02, -4.831791e-02, 1.732665e-01
-5163, 1.069204e-02, -4.884343e-02, 1.819056e-01
-5164, 1.188754e-02, -4.856631e-02, 2.717606e-01
-5165, 1.018354e-03, -4.998963e-02, 2.755706e-01
-5166, 9.425790e-03, -4.910351e-02, 1.914598e-01
-5167, 8.570930e-03, -4.925991e-02, 2.001518e-01
-5168, 4.845697e-03, -4.976464e-02, 2.276594e-01
-5169, 4.367270e-03, -4.980890e-02, 2.374597e-01
-5170, 1.467215e-02, -4.779883e-02, 8.370149e-02
-5171, 3.530891e-03, -4.987517e-02, 8.720729e-02
-5172, -1.358532e-02, -4.811901e-02, 4.234845e-01
-5173, 6.933095e-03, -4.951699e-02, 3.874167e-01
-5174, -3.924861e-02, -3.097655e-02, 4.192980e-01
-5175, -4.433913e-02, -2.310934e-02, 4.150136e-01
-5176, -3.714056e-03, 4.986187e-02, 3.686062e-01
-5177, 7.201190e-03, 4.947871e-02, 3.648506e-01
-5178, 1.001538e-02, -4.898665e-02, 1.206845e-01
-5179, -1.495088e-03, -4.997764e-02, 1.248199e-01
-5180, -1.292749e-02, -4.829990e-02, 2.911413e-01
-5181, -1.301365e-02, -4.827675e-02, 3.021793e-01
-5182, -1.025677e-02, -4.893668e-02, 1.054920e-01
-5183, -8.548499e-03, -4.926381e-02, 1.150243e-01
-5184, -5.234452e-03, -4.972525e-02, 2.227884e-01
-5185, -2.257696e-02, -4.461256e-02, 3.096598e-01
-5186, -1.215343e-02, -4.850046e-02, 3.157745e-01
-5187, -9.602642e-03, -4.906923e-02, 2.670788e-01
-5188, -1.238942e-02, -4.844071e-02, 2.777262e-01
-5189, -1.586864e-02, -4.741504e-02, 2.172555e-01
-5190, -1.716734e-02, -4.696044e-02, 2.266869e-01
-5191, -1.549792e-02, 4.753751e-02, 3.758213e-01
-5192, -1.645864e-02, 4.721349e-02, 3.641304e-01
-5193, -1.220037e-02, -4.848867e-02, 1.244945e-01
-5194, -7.660392e-03, 4.940970e-02, 3.995699e-01
-5195, -1.009167e-02, 4.897099e-02, 3.893702e-01
-5196, -2.239018e-02, 4.470660e-02, 3.848945e-01
-5197, -9.879202e-03, 4.901430e-02, 4.099155e-01
-5198, -2.254893e-02, 4.462674e-02, 6.209182e-02
-5199, -2.905949e-02, 4.068840e-02, 5.852148e-02
-5200, -3.494224e-02, 3.576367e-02, 5.973812e-02
-5201, -3.689297e-02, 3.374772e-02, 6.864058e-02
-5202, -4.099810e-02, 2.862090e-02, 6.144485e-02
-5203, -4.485243e-02, 2.209659e-02, 6.195209e-02
-5204, -4.813090e-02, 1.354313e-02, 6.184734e-02
-5205, -4.956940e-02, 6.547898e-03, 6.162259e-02
-5206, -4.661858e-02, 1.807506e-02, 7.024257e-02
-5207, -4.993878e-02, -2.473570e-03, 6.006766e-02
-5208, -4.919247e-02, -8.949888e-03, 5.843368e-02
-5209, -4.999922e-02, 2.794249e-04, 6.858290e-02
-5210, -4.764262e-02, -1.517172e-02, 6.090431e-02
-5211, -4.402036e-02, -2.371092e-02, 6.572485e-02
-5212, -4.004383e-02, -2.994147e-02, 6.566574e-02
-5213, -4.677686e-02, -1.766141e-02, 7.184851e-02
-5214, -3.257471e-02, -3.793268e-02, 6.200882e-02
-5215, -1.126390e-02, 4.871473e-02, 1.565429e-01
-5216, -1.265268e-02, 4.837261e-02, 1.468617e-01
-5217, -1.311255e-02, 4.824998e-02, 1.367042e-01
-5218, -1.534548e-02, 4.758693e-02, 1.261953e-01
-5219, -2.221455e-02, 4.479413e-02, 1.456882e-01
-5220, -9.823247e-03, -4.902554e-02, 3.268362e-01
-5221, -1.511431e-02, -4.766086e-02, 3.373554e-01
-5222, 1.577880e-02, 4.744502e-02, 1.749416e-01
-5223, 1.308323e-02, 4.825794e-02, 1.672919e-01
-5224, 2.668855e-03, 4.992872e-02, 1.658314e-01
-5225, 9.722790e-03, 4.904556e-02, 1.812450e-01
-5226, -1.417593e-02, 4.794834e-02, 2.706302e-01
-5227, -1.717922e-02, 4.695609e-02, 2.610722e-01
-5228, -2.251387e-02, 4.464443e-02, 2.791521e-01
-5229, -4.990622e-02, -3.060933e-03, 4.224740e-01
-5230, -4.978529e-02, 4.628711e-03, 4.316544e-01
-5231, -2.839770e-02, 4.115301e-02, 4.298764e-01
-5232, -1.949635e-02, 4.604229e-02, 4.299401e-01
-5233, -4.765586e-02, 1.513008e-02, 4.329856e-01
-5234, -3.603426e-02, -3.466312e-02, 7.301212e-02
-5235, -3.391025e-02, 3.674364e-02, 4.206678e-01
-5236, -4.648773e-02, 1.840899e-02, 4.216306e-01
-5237, -4.854149e-02, 1.198847e-02, 4.114208e-01
-5238, -4.477863e-02, 2.224578e-02, 4.112621e-01
-5239, -4.877925e-02, -1.098113e-02, 4.122362e-01
-5240, -4.999989e-02, -1.035867e-04, 4.115515e-01
-5241, -4.983217e-02, 4.093298e-03, 4.011830e-01
-5242, -4.562843e-02, -2.044618e-02, 4.040911e-01
-5243, -1.384753e-02, 4.804421e-02, 4.206257e-01
-5244, -2.287327e-02, -4.446137e-02, 2.826495e-01
-5245, -1.268714e-02, 4.836359e-02, 9.757436e-02
-5246, -2.025517e-02, 4.571354e-02, 9.058946e-02
-5247, -1.567752e-02, 4.747858e-02, 1.089525e-01
-5248, -2.699854e-02, 4.208419e-02, 3.543550e-01
-5249, -1.618336e-02, 4.730855e-02, 3.471399e-01
-5250, -3.233865e-02, -3.813413e-02, 4.154857e-01
-5251, -6.432118e-03, -4.958455e-02, 3.660029e-01
-5252, -5.885830e-03, -4.965236e-02, 8.651762e-02
-5253, 5.330596e-03, 4.971504e-02, 1.992982e-01
-5254, 4.998805e-03, 4.974949e-02, 1.908783e-01
-5255, 7.419123e-04, 4.999450e-02, 1.840560e-01
-5256, -5.819754e-03, 4.966015e-02, 2.055654e-01
-5257, -7.427270e-03, -4.944528e-02, 4.036845e-01
-5258, -9.694998e-03, -4.905107e-02, 4.135812e-01
-5259, -1.122622e-03, -4.998740e-02, 1.456039e-01
-5260, -2.486517e-03, -4.993813e-02, 2.579694e-01
-5261, -1.575282e-02, -4.745365e-02, 2.601250e-01
-5262, 1.246168e-03, -4.998447e-02, 1.856925e-01
-5263, -2.768509e-02, -4.163575e-02, 2.323671e-01
-5264, -1.802140e-02, -4.663935e-02, 2.379000e-01
-5265, -1.956738e-03, -4.996170e-02, 2.043019e-01
-5266, -7.704551e-03, -4.940283e-02, 2.416177e-01
-5267, 3.255238e-03, -4.989392e-02, 2.468576e-01
-5268, -2.019502e-02, 4.574015e-02, 3.115013e-01
-5269, -2.400863e-02, 4.385870e-02, 3.013515e-01
-5270, -2.112362e-02, -4.531879e-02, 4.141997e-01
-5271, -2.443596e-02, -4.362206e-02, 1.249782e-01
-5272, -1.802077e-02, -4.663960e-02, 1.347737e-01
-5273, 6.615412e-03, 4.956043e-02, 3.565496e-01
-5274, 3.420620e-03, 4.988286e-02, 3.496042e-01
-5275, -2.113261e-02, 4.531460e-02, 1.193604e-01
-5276, -2.828627e-02, 4.122969e-02, 1.114532e-01
-5277, -2.799757e-02, 4.142627e-02, 1.286959e-01
-5278, -1.725093e-02, 4.692979e-02, 2.076250e-01
-5279, -1.555354e-02, 4.751934e-02, 1.957489e-01
-5280, -9.145675e-04, -4.999163e-02, 3.918113e-01
-5281, -1.117174e-02, -4.873594e-02, 3.924232e-01
-5282, -1.827028e-02, 4.654242e-02, 3.243535e-01
-5283, -2.849096e-02, 4.108851e-02, 3.245122e-01
-5284, -3.010792e-03, 4.990927e-02, 3.435904e-01
-5285, -2.400702e-02, 4.385958e-02, 2.535996e-01
-5286, -2.380967e-02, 4.396703e-02, 7.353377e-02
-5287, -3.855894e-02, 3.183093e-02, 4.103801e-01
-5288, -3.030762e-02, 3.976743e-02, 4.095761e-01
-5289, 2.760095e-03, -4.992376e-02, 1.665279e-01
-5290, -4.249019e-02, 2.635496e-02, 4.001704e-01
-5291, -5.080659e-03, 4.974120e-02, 1.752239e-01
-5292, -7.905901e-03, 4.937101e-02, 1.666326e-01
-5293, -1.865832e-02, 4.638822e-02, 1.659354e-01
-5294, -9.803479e-03, 4.902950e-02, 1.848572e-01
-5295, -1.844070e-02, -4.647516e-02, 3.589114e-01
-5296, -1.682818e-02, -4.708304e-02, 3.734585e-01
-5297, -3.657290e-02, -3.409433e-02, 8.504733e-02
-5298, -2.828377e-02, -4.123140e-02, 8.139041e-02
-5299, -1.926994e-02, -4.613751e-02, 3.479910e-01
-5300, -2.863949e-02, -4.098512e-02, 3.554466e-01
-5301, -2.198303e-02, 4.490820e-02, 2.191685e-01
-5302, -3.045324e-02, 3.965602e-02, 2.093521e-01
-5303, -2.779789e-02, 4.156052e-02, 2.304168e-01
-5304, -2.829890e-02, -4.122102e-02, 3.770718e-01
-5305, -1.728037e-02, -4.691896e-02, 3.841632e-01
-5306, -4.458789e-02, -2.262564e-02, 8.841288e-02
-5307, -3.909405e-02, -3.117139e-02, 9.679117e-02
-5308, -2.645445e-02, 4.242832e-02, 8.304228e-02
-5309, -3.234590e-02, 3.812798e-02, 7.644237e-02
-5310, -2.922676e-02, 4.056842e-02, 9.349806e-02
-5311, -1.576914e-02, -4.744823e-02, 9.485534e-02
-5312, -2.408799e-02, -4.381517e-02, 1.040623e-01
-5313, -2.325249e-02, -4.426423e-02, 3.960364e-01
-5314, -3.717634e-02, -3.343530e-02, 3.732091e-01
-5315, -3.749629e-02, -3.307609e-02, 3.839139e-01
-5316, -3.814359e-02, 3.232749e-02, 3.630788e-01
-5317, -3.795465e-02, 3.254911e-02, 3.460882e-01
-5318, -3.507940e-02, 3.562914e-02, 2.564213e-01
-5319, -3.213417e-02, 3.830660e-02, 2.427598e-01
-5320, -2.918654e-02, -4.059737e-02, 4.055824e-01
-5321, -3.814587e-02, 3.232480e-02, 3.296585e-01
-5322, -3.946051e-02, 3.070615e-02, 3.168063e-01
-5323, -4.594247e-02, 1.973042e-02, 3.383823e-01
-5324, -3.223324e-02, 3.822327e-02, 1.518125e-01
-5325, -3.259562e-02, 3.791471e-02, 1.416551e-01
-5326, -2.411998e-02, -4.379757e-02, 1.425828e-01
-5327, -1.184953e-02, -4.857560e-02, 1.420992e-01
-5328, -3.795453e-02, -3.254925e-02, 2.249537e-01
-5329, -3.854216e-02, -3.185125e-02, 2.361669e-01
-5330, -1.100457e-02, -4.877396e-02, 1.983315e-01
-5331, -1.286004e-02, -4.831790e-02, 2.073867e-01
-5332, -1.454786e-02, 4.783680e-02, 3.338149e-01
-5333, -2.547206e-02, -4.302527e-02, 2.564073e-01
-5334, -3.646003e-02, -3.421500e-02, 2.500445e-01
-5335, -3.395869e-02, -3.669887e-02, 2.628716e-01
-5336, -4.438361e-02, -2.302380e-02, 2.426312e-01
-5337, -2.988342e-02, -4.008717e-02, 1.161834e-01
-5338, -3.454766e-02, -3.614497e-02, 1.264626e-01
-5339, -2.103034e-02, 4.536215e-02, 4.091536e-01
-5340, -2.696003e-02, 4.210887e-02, 3.988659e-01
-5341, -3.888816e-02, 3.142787e-02, 7.814909e-02
-5342, -4.173101e-02, 2.754129e-02, 8.687988e-02
-5343, -4.486911e-02, 2.206271e-02, 7.907809e-02
-5344, -4.814112e-02, 1.350678e-02, 7.897335e-02
-5345, -4.950118e-02, 7.045073e-03, 8.678448e-02
-5346, -4.992643e-02, 2.711343e-03, 7.794895e-02
-5347, -4.960001e-02, -6.311783e-03, 7.639402e-02
-5348, -7.517370e-03, -4.943166e-02, 1.624781e-01
-5349, -7.737245e-03, -4.939772e-02, 1.720884e-01
-5350, -7.824364e-03, -4.938400e-02, 1.534129e-01
-5351, -1.797501e-02, -4.665725e-02, 1.589734e-01
-5352, -3.555497e-02, 3.515458e-02, 3.020619e-01
-5353, -3.001668e-02, 3.998748e-02, 2.917534e-01
-5354, -3.434755e-02, 3.633519e-02, 2.798624e-01
-5355, -4.343542e-02, 2.476620e-02, 3.072081e-01
-5356, -2.011601e-02, -4.577495e-02, 8.508790e-02
-5357, -3.293917e-02, -3.761663e-02, 2.758597e-01
-5358, -3.335557e-02, -3.724790e-02, 2.892748e-01
-5359, -2.567516e-02, -4.290438e-02, 3.338906e-01
-5360, -1.905716e-02, -4.622580e-02, 2.472979e-01
-5361, -3.323894e-02, 3.735202e-02, 1.030373e-01
-5362, -3.814000e-02, 3.233173e-02, 9.549007e-02
-5363, -3.738653e-02, 3.320011e-02, 1.134452e-01
-5364, -2.422192e-02, -4.374127e-02, 2.112851e-01
-5365, -3.323655e-02, -3.735414e-02, 3.014668e-01
-5366, -3.256729e-02, -3.793905e-02, 3.150620e-01
-5367, -4.127794e-02, -2.821581e-02, 2.946770e-01
-5368, -4.758063e-02, -1.536501e-02, 8.121456e-02
-5369, -4.862414e-02, -1.164871e-02, 9.295839e-02
-5370, -3.330536e-02, -3.729280e-02, 1.475779e-01
-5371, -2.821277e-02, -4.128001e-02, 1.549034e-01
-5372, -2.097740e-02, 4.538666e-02, 1.869169e-01
-5373, -6.099220e-03, -4.962660e-02, 1.806521e-01
-5374, -7.380107e-03, -4.945234e-02, 1.902063e-01
-5375, -1.612827e-02, -4.732736e-02, 1.766022e-01
-5376, -3.425888e-02, -3.641880e-02, 1.055467e-01
-5377, -1.803989e-02, -4.663220e-02, 1.932911e-01
-5378, -3.636835e-02, -3.431243e-02, 3.604399e-01
-5379, -4.363752e-02, -2.440833e-02, 3.672820e-01
-5380, -3.697692e-02, -3.365571e-02, 3.495195e-01
-5381, -3.704902e-02, 3.357633e-02, 1.348202e-01
-5382, -2.672467e-02, 4.225863e-02, 1.755552e-01
-5383, -2.955219e-02, 4.033197e-02, 1.654655e-01
-5384, -3.155148e-02, 3.878794e-02, 1.864469e-01
-5385, -3.809766e-02, 3.238160e-02, 2.332385e-01
-5386, -3.411357e-02, -3.655495e-02, 3.973225e-01
-5387, -3.860291e-02, 3.177759e-02, 1.614323e-01
-5388, -2.404466e-02, -4.383896e-02, 1.841796e-01
-5389, -2.721011e-02, -4.194771e-02, 1.923048e-01
-5390, -4.300856e-02, -2.550028e-02, 1.089123e-01
-5391, -3.149433e-02, 3.883435e-02, 3.853170e-01
-5392, -4.995365e-02, -2.152302e-03, 3.907563e-01
-5393, -4.899197e-02, 9.989359e-03, 3.906256e-01
-5394, -3.197075e-02, -3.844309e-02, 2.027631e-01
-5395, -3.432158e-02, -3.635972e-02, 2.126319e-01
-5396, -4.336945e-02, -2.488154e-02, 2.164317e-01
-5397, -3.677103e-02, -3.388055e-02, 1.936516e-01
-5398, -4.173465e-02, -2.753578e-02, 3.934599e-01
-5399, -4.212260e-02, -2.693857e-02, 2.694969e-01
-5400, -4.998974e-02, 1.012757e-03, 9.546885e-02
-5401, -4.953171e-02, -6.827111e-03, 1.026672e-01
-5402, -4.739546e-02, -1.592702e-02, 3.906825e-01
-5403, -4.433905e-02, 2.310949e-02, 9.641907e-02
-5404, -4.552543e-02, 2.067451e-02, 3.906492e-01
-5405, -3.964296e-02, 3.047024e-02, 3.897672e-01
-5406, -3.839973e-02, -3.202281e-02, 1.376541e-01
-5407, -4.129632e-02, -2.818890e-02, 1.499747e-01
-5408, -4.222612e-02, -2.677601e-02, 1.288594e-01
-5409, -3.622492e-02, 3.446382e-02, 3.757958e-01
-5410, -3.673867e-02, 3.391564e-02, 1.985252e-01
-5411, -4.085301e-02, 2.882762e-02, 1.871635e-01
-5412, -4.002996e-02, 2.996001e-02, 2.100687e-01
-5413, -4.774806e-02, 1.483652e-02, 3.802224e-01
-5414, -4.816486e-02, -1.342185e-02, 1.114881e-01
-5415, -4.576388e-02, -2.014118e-02, 1.202436e-01
-5416, -4.774160e-02, -1.485730e-02, 1.314352e-01
-5417, -4.999329e-02, -8.188889e-04, 1.139986e-01
-5418, -4.460163e-02, 2.259855e-02, 3.675290e-01
-5419, -3.316601e-02, -3.741679e-02, 3.270009e-01
-5420, -3.634498e-02, -3.433719e-02, 3.376364e-01
-5421, -4.256266e-02, -2.623776e-02, 3.426297e-01
-5422, -4.163292e-02, -2.768935e-02, 3.188078e-01
-5423, -4.680632e-02, 1.758318e-02, 1.051034e-01
-5424, -4.857240e-02, 1.186264e-02, 9.649325e-02
-5425, -4.926795e-02, 8.524640e-03, 3.474405e-01
-5426, -4.931735e-02, 8.234043e-03, 3.310108e-01
-5427, -4.452838e-02, 2.274254e-02, 1.744900e-01
-5428, -4.597534e-02, 1.965369e-02, 1.608370e-01
-5429, -4.730613e-02, 1.619042e-02, 1.865682e-01
-5430, -4.382169e-02, 2.407613e-02, 2.813966e-01
-5431, -3.890273e-02, 3.140983e-02, 2.687953e-01
-5432, -4.740466e-02, -1.589964e-02, 3.583107e-01
-5433, -4.777037e-02, -1.476454e-02, 3.710799e-01
-5434, -4.430226e-02, 2.317993e-02, 2.579554e-01
-5435, -4.743019e-02, 1.582331e-02, 2.937033e-01
-5436, -4.912158e-02, 9.331165e-03, 2.826362e-01
-5437, -4.896785e-02, 1.010690e-02, 3.084477e-01
-5438, -4.903370e-02, 9.782423e-03, 2.592741e-01
-5439, -4.760357e-02, 1.529378e-02, 2.469002e-01
-5440, -4.784680e-02, -1.451496e-02, 2.887140e-01
-5441, -4.780024e-02, -1.466756e-02, 3.009059e-01
-5442, -4.108043e-02, 2.850260e-02, 1.236128e-01
-5443, -4.433394e-02, 2.311930e-02, 1.151968e-01
-5444, -4.856977e-02, 1.187338e-02, 1.152710e-01
-5445, -4.409798e-02, 2.356626e-02, 1.365719e-01
-5446, -4.852102e-02, 1.207107e-02, 3.675054e-01
-5447, -2.795574e-02, -4.145451e-02, 1.639685e-01
-5448, -4.569060e-02, 2.030687e-02, 2.349820e-01
-5449, -4.322343e-02, 2.513433e-02, 2.226390e-01
-5450, -4.686052e-02, 1.743822e-02, 2.118121e-01
-5451, -4.955783e-02, 6.634844e-03, 2.363007e-01
-5452, -2.548144e-02, -4.301972e-02, 1.756160e-01
-5453, -4.774671e-02, -1.484089e-02, 3.472909e-01
-5454, -4.979252e-02, -4.550222e-03, 3.510888e-01
-5455, -4.972485e-02, 5.238279e-03, 1.240919e-01
-5456, -4.895299e-02, -1.017866e-02, 3.801250e-01
-5457, -4.702408e-02, -1.699223e-02, 2.033062e-01
-5458, -4.855013e-02, -1.195345e-02, 2.156280e-01
-5459, -4.699632e-02, 1.706886e-02, 1.465647e-01
-5460, -4.880919e-02, 1.084725e-02, 1.353572e-01
-5461, -4.996494e-02, -1.872199e-03, 1.340847e-01
-5462, -4.956593e-02, 6.574080e-03, 1.596223e-01
-5463, -4.999132e-02, -9.314469e-04, 3.711536e-01
-5464, -4.944543e-02, 7.426250e-03, 3.584603e-01
-5465, -4.905337e-02, -9.683333e-03, 2.384862e-01
-5466, -4.834627e-02, -1.275296e-02, 2.523638e-01
-5467, -4.683344e-02, -1.751081e-02, 1.503266e-01
-5468, -4.377012e-02, -2.416975e-02, 1.602503e-01
-5469, -4.707320e-02, -1.685567e-02, 2.637459e-01
-5470, -4.659309e-02, -1.814066e-02, 2.767340e-01
-5471, -4.746261e-02, -1.572579e-02, 3.354079e-01
-5472, -4.990938e-02, -3.008978e-03, 2.596009e-01
-5473, -4.980857e-02, -4.371066e-03, 2.265680e-01
-5474, -4.969241e-02, 5.537538e-03, 2.706562e-01
-5475, -4.987960e-02, -3.467747e-03, 2.829630e-01
-5476, -4.968022e-02, -5.645883e-03, 3.290879e-01
-5477, -4.963350e-02, 6.042830e-03, 3.200296e-01
-5478, -4.671995e-02, -1.781141e-02, 3.244267e-01
-5479, -4.911922e-02, -9.343576e-03, 1.427005e-01
-5480, -3.468279e-02, -3.601533e-02, 1.715459e-01
-5481, -4.981271e-02, 4.323626e-03, 2.134425e-01
-5482, -4.978136e-02, -4.670798e-03, 1.529761e-01
-5483, -4.897956e-02, 1.004999e-02, 2.008721e-01
-5484, -4.643104e-02, -1.855151e-02, 3.124878e-01
-5485, -4.222259e-02, -2.678157e-02, 1.708850e-01
-5486, -4.058266e-02, -2.920698e-02, 1.825324e-01
-5487, -4.374613e-02, -2.421314e-02, 1.929907e-01
-5488, -4.739682e-02, -1.592299e-02, 1.712369e-01
-5489, -4.990979e-02, 3.002206e-03, 1.881986e-01
-5490, -4.985924e-02, -3.749124e-03, 3.065248e-01
-5491, -4.872783e-02, -1.120708e-02, 1.921870e-01
-5492, -4.996398e-02, -1.897641e-03, 1.672484e-01
-5493, -4.975671e-02, -4.926419e-03, 1.778831e-01
-5494, -2.264554e-02, -5.011018e-02, 4.835991e-01
-5495, -1.762118e-02, -5.196067e-02, 4.835518e-01
-5496, -2.031248e-02, -5.109662e-02, 4.892575e-01
-5497, 5.087277e-02, -2.085659e-02, 2.517501e-01
-5498, 5.229689e-02, -1.589939e-02, 2.470257e-01
-5499, 4.995994e-02, -2.298894e-02, 2.449104e-01
-5500, 5.230581e-02, 1.648407e-02, 2.248690e-01
-5501, 5.392957e-02, 1.071924e-02, 2.221429e-01
-5502, 5.391832e-02, 1.078262e-02, 2.276858e-01
-5503, 5.226917e-02, 1.681630e-02, 2.692906e-01
-5504, 5.223854e-02, 1.689630e-02, 2.747269e-01
-5505, 4.877767e-02, 2.463651e-02, 2.694828e-01
-5506, 4.874704e-02, 2.471652e-02, 2.749191e-01
-5507, 5.208267e-02, 1.694860e-02, 1.360299e-01
-5508, 5.220151e-02, 1.666174e-02, 1.415400e-01
-5509, 5.392933e-02, 1.076328e-02, 1.389063e-01
-5510, -5.375297e-02, 9.210985e-03, 4.436955e-01
-5511, -5.495089e-02, -8.617918e-04, 4.419756e-01
-5512, -5.473426e-02, 4.596764e-03, 4.315780e-01
-5513, 3.719820e-02, -4.050914e-02, 2.166358e-01
-5514, 3.819592e-02, -3.953147e-02, 2.069935e-01
-5515, 2.836531e-02, -4.624028e-02, 2.100099e-01
-5516, 4.526451e-02, -3.099357e-02, 3.648293e-01
-5517, 4.959305e-02, -2.343670e-02, 3.635227e-01
-5518, 4.881305e-02, -2.524448e-02, 3.704483e-01
-5519, 5.440779e-02, 8.048529e-03, 2.259444e-02
-5520, 5.354834e-02, 1.202640e-02, 1.880854e-02
-5521, 5.448797e-02, 7.458095e-03, 1.768739e-02
-5522, -2.751747e-02, -4.762060e-02, 4.834874e-01
-5523, -2.964928e-02, -4.625259e-02, 4.775673e-01
-5524, -2.523468e-02, -4.882437e-02, 4.778231e-01
-5525, 1.227586e-02, -5.310804e-02, 4.525294e-01
-5526, 8.781778e-03, -5.414485e-02, 4.420211e-01
-5527, 2.081237e-02, -5.085535e-02, 4.566354e-01
-5528, 1.731829e-02, -5.189216e-02, 4.461271e-01
-5529, -2.725097e-02, -4.777431e-02, 4.706161e-01
-5530, -3.135494e-02, -4.484574e-02, 4.653319e-01
-5531, -3.375326e-02, -4.332403e-02, 4.722830e-01
-5532, 4.830660e-02, 2.609483e-02, 4.473958e-02
-5533, 5.073365e-02, 2.116466e-02, 4.858113e-02
-5534, 5.098962e-02, 2.047080e-02, 4.263157e-02
-5535, 5.500000e-02, -1.347111e-17, 4.275072e-01
-5536, 5.460876e-02, -4.829195e-03, 4.297571e-01
-5537, 5.500000e-02, -1.347111e-17, 4.324904e-01
-5538, 1.813452e-02, 5.161660e-02, 2.188468e-01
-5539, 1.018162e-02, 5.393849e-02, 2.266247e-01
-5540, 1.811514e-02, 5.162142e-02, 2.310095e-01
-5541, 1.016224e-02, 5.394331e-02, 2.387875e-01
-5542, 4.214424e-02, -3.524001e-02, 2.500853e-01
-5543, 3.233440e-02, -4.354378e-02, 2.505033e-01
-5544, 3.966072e-02, -3.809686e-02, 2.426102e-01
-5545, 5.400102e-02, 1.025495e-02, 1.354221e-02
-5546, 5.239166e-02, -1.502053e-02, 3.410144e-01
-5547, 5.203266e-02, -1.690401e-02, 3.465592e-01
-5548, 5.408005e-02, -9.905547e-03, 3.440704e-01
-5549, 5.372106e-02, -1.178903e-02, 3.496153e-01
-5550, 5.440575e-02, -5.418418e-03, 2.689784e-01
-5551, 5.372022e-02, -1.179510e-02, 2.719135e-01
-5552, 5.440575e-02, -5.418418e-03, 2.752886e-01
-5553, 1.036206e-03, 5.487341e-02, 4.478080e-01
-5554, 9.007855e-03, 5.412810e-02, 4.457699e-01
-5555, 3.686836e-03, 5.486393e-02, 4.385080e-01
-5556, -4.819395e-02, 2.569952e-02, 8.072987e-02
-5557, -4.211105e-02, 3.491644e-02, 7.980087e-02
-5558, -4.494086e-02, 2.972095e-02, 9.105696e-02
-5559, -5.102377e-02, 2.050403e-02, 9.198596e-02
-5560, -9.395956e-03, -5.418991e-02, 3.494173e-01
-5561, -3.947890e-03, -5.448509e-02, 3.388981e-01
-5562, 4.342281e-03, -5.346357e-02, 3.505029e-01
-5563, 9.790347e-03, -5.375876e-02, 3.399837e-01
-5564, -4.362828e-02, -3.346399e-02, 1.759902e-02
-5565, -4.204566e-02, -3.542699e-02, 1.133869e-02
-5566, -4.496703e-02, -3.141674e-02, 1.180310e-02
-5567, 5.419747e-02, -9.333399e-03, 3.270458e-02
-5568, 5.419134e-02, -9.366073e-03, 2.660242e-02
-5569, 5.462371e-02, -4.736667e-03, 3.045671e-02
-5570, -2.602394e-02, -4.823901e-02, 6.721254e-02
-5571, -2.475262e-02, -4.902838e-02, 5.727948e-02
-5572, -1.771748e-02, -5.178936e-02, 6.088820e-02
-5573, -4.317617e-02, -3.392376e-02, 4.719400e-03
-5574, -4.609755e-02, -2.991351e-02, 5.183813e-03
-5575, 2.123510e-02, 5.071138e-02, 4.950504e-01
-5576, 2.012521e-02, -5.116458e-02, 2.068352e-01
-5577, 1.967835e-02, -5.132064e-02, 2.158563e-01
-5578, 5.229839e-02, -1.651969e-02, 3.324209e-01
-5579, 5.237301e-02, -1.618100e-02, 3.378692e-01
-5580, 5.007010e-02, -2.256683e-02, 3.352610e-01
-5581, 5.463392e-02, -4.672318e-03, 3.409868e-01
-5582, 5.408509e-02, -9.881949e-03, 3.382907e-01
-5583, 5.463392e-02, -4.672318e-03, 3.356193e-01
-5584, -1.135371e-02, 5.381211e-02, 4.620892e-01
-5585, -9.175393e-03, 5.414595e-02, 4.705359e-01
-5586, -1.482076e-02, 5.285954e-02, 4.696230e-01
-5587, 5.455055e-02, 5.173470e-03, 1.136369e-01
-5588, 5.455055e-02, 5.173470e-03, 1.199695e-01
-5589, 5.393237e-02, 1.069860e-02, 1.167308e-01
-5590, 1.679501e-02, -5.234902e-02, 3.481993e-01
-5591, 4.012266e-02, -3.746775e-02, 2.999500e-01
-5592, 4.616326e-02, -2.930426e-02, 3.048905e-01
-5593, 4.645197e-02, -2.871568e-02, 2.980892e-01
-5594, 5.416097e-02, 9.568701e-03, 2.775095e-01
-5595, 5.416821e-02, 9.526832e-03, 2.830769e-01
-5596, 5.455730e-02, 5.134766e-03, 2.751945e-01
-5597, 5.456455e-02, 5.092896e-03, 2.807619e-01
-5598, 4.072639e-02, 3.654443e-02, 3.601051e-01
-5599, 4.047444e-02, 3.687864e-02, 3.538482e-01
-5600, 3.360208e-02, 4.340104e-02, 3.577164e-01
-5601, -2.020976e-02, -5.100256e-02, 4.771433e-01
-5602, -1.518540e-02, -5.285305e-02, 4.770959e-01
-5603, 5.372274e-02, 1.175920e-02, 4.952757e-01
-5604, -5.467092e-02, -5.935393e-03, 4.830347e-01
-5605, -5.487110e-02, -2.775510e-03, 4.765281e-01
-5606, -5.473427e-02, -1.175318e-03, 4.843783e-01
-5607, -5.493445e-02, 1.984566e-03, 4.778717e-01
-5608, 3.527072e-02, 4.208365e-02, 1.503381e-01
-5609, 3.581072e-02, 4.155421e-02, 1.416550e-01
-5610, 2.693800e-02, 4.733266e-02, 1.467771e-01
-5611, 5.128328e-02, -1.935463e-02, 4.910551e-01
-5612, 5.062533e-02, -2.138456e-02, 4.859498e-01
-5613, 4.930926e-02, -2.432659e-02, 4.907937e-01
-5614, -2.947102e-02, -4.638199e-02, 4.898946e-01
-5615, -2.492833e-02, -4.890640e-02, 4.892634e-01
-5616, -2.752208e-02, -4.761796e-02, 4.946928e-01
-5617, -1.501483e-02, 5.290900e-02, 4.343527e-01
-5618, -1.533085e-02, 5.281993e-02, 4.448331e-01
-5619, -8.253408e-03, 5.396494e-02, 4.450153e-01
-5620, -5.420339e-02, -8.517319e-03, 4.768997e-01
-5621, -5.396289e-02, -1.043266e-02, 4.693316e-01
-5622, -5.463060e-02, -4.690848e-03, 4.689600e-01
-5623, -4.961833e-02, -2.372794e-02, 4.782898e-01
-5624, -5.148577e-02, -1.869237e-02, 4.780515e-01
-5625, -5.072602e-02, -2.108588e-02, 4.721921e-01
-5626, 5.230747e-02, -1.610164e-02, 4.703397e-01
-5627, 4.938008e-02, -2.410571e-02, 4.694681e-01
-5628, 5.095900e-02, -2.066277e-02, 4.636949e-01
-5629, 5.023427e-02, 2.221194e-02, 3.776905e-01
-5630, 4.751315e-02, 2.757731e-02, 3.752962e-01
-5631, 4.698288e-02, 2.837655e-02, 3.807146e-01
-5632, 4.974097e-02, 2.334075e-02, 1.276570e-01
-5633, 5.000254e-02, 2.269775e-02, 1.222481e-01
-5634, 4.590563e-02, 2.995224e-02, 1.239847e-01
-5635, 5.316134e-02, 1.344002e-02, 4.652763e-01
-5636, 5.307366e-02, 1.394274e-02, 4.703232e-01
-5637, 5.153973e-02, 1.907789e-02, 4.663278e-01
-5638, 2.101094e-02, -5.081583e-02, 4.729850e-01
-5639, 2.609651e-02, -4.798381e-02, 4.674822e-01
-5640, 1.929241e-02, -5.150240e-02, 4.651528e-01
-5641, 5.242600e-02, 1.597712e-02, 8.629123e-02
-5642, 5.406000e-02, 1.007716e-02, 8.897385e-02
-5643, 5.401851e-02, 1.031597e-02, 8.353524e-02
-5644, 3.512162e-02, 4.163400e-02, 4.663914e-01
-5645, 3.301616e-02, 4.370970e-02, 4.727980e-01
-5646, 2.950407e-02, 4.640799e-02, 4.667903e-01
-5647, 3.478667e-02, -4.251583e-02, 4.728022e-01
-5648, 3.733422e-02, -3.993957e-02, 4.673411e-01
-5649, 3.183725e-02, -4.484257e-02, 4.660008e-01
-5650, -3.162358e-02, -4.499940e-02, 4.952017e-01
-5651, -3.359921e-02, -4.348144e-02, 4.899293e-01
-5652, 2.213293e-02, -5.032229e-02, 4.953728e-01
-5653, -1.402217e-02, 5.306520e-02, 3.336501e-02
-5654, -1.808485e-02, 5.139403e-02, 4.324681e-02
-5655, -7.093859e-03, 5.446170e-02, 4.134351e-02
-5656, 3.461119e-02, 4.241168e-02, 1.311681e-01
-5657, 2.573848e-02, 4.819012e-02, 1.362903e-01
-5658, 3.009302e-02, -4.544460e-02, 1.900160e-01
-5659, 4.057284e-02, -3.677643e-02, 1.911267e-01
-5660, 3.819975e-02, -3.952803e-02, 1.997633e-01
-5661, 4.239316e-02, -3.499586e-02, 4.678973e-01
-5662, 4.101506e-02, -3.663907e-02, 4.613867e-01
-5663, 2.607630e-02, -4.837346e-02, 2.273808e-02
-5664, 2.776834e-02, -4.726592e-02, 2.945637e-02
-5665, 3.231720e-02, -4.450207e-02, 2.725966e-02
-5666, 3.062515e-02, -4.560961e-02, 2.054137e-02
-5667, 3.469693e-02, 4.262235e-02, 4.949914e-01
-5668, 3.670927e-02, 4.069123e-02, 4.897879e-01
-5669, 3.285876e-02, 4.410555e-02, 4.900675e-01
-5670, -3.024307e-02, -4.371104e-02, 4.068644e-01
-5671, -1.952508e-02, -5.141649e-02, 4.055784e-01
-5672, -3.870060e-02, -3.872181e-02, 4.015877e-01
-5673, -2.798262e-02, -4.642726e-02, 4.003017e-01
-5674, 5.500000e-02, -1.347111e-17, 4.225239e-01
-5675, 5.454882e-02, 5.183379e-03, 4.195845e-01
-5676, 5.455343e-02, 5.157013e-03, 4.251046e-01
-5677, 5.181436e-02, -1.757750e-02, 6.947992e-02
-5678, 4.986650e-02, -2.318405e-02, 6.604973e-02
-5679, 4.973853e-02, -2.344289e-02, 7.216988e-02
-5680, 2.915764e-02, -4.662010e-02, 5.841624e-02
-5681, 3.177475e-02, -4.470129e-02, 4.494878e-02
-5682, 3.494367e-02, -4.188931e-02, 6.206006e-02
-5683, 3.756078e-02, -3.997050e-02, 4.859260e-02
-5684, -2.405657e-02, -4.890338e-02, 2.534346e-01
-5685, -1.423872e-02, -5.295091e-02, 2.571523e-01
-5686, -2.506794e-02, -4.853188e-02, 2.395504e-01
-5687, -1.525008e-02, -5.257942e-02, 2.432680e-01
-5688, 5.433264e-02, -6.292543e-03, 3.020744e-01
-5689, 5.500000e-02, -1.347111e-17, 3.050418e-01
-5690, 5.450907e-02, -4.930079e-03, 3.079679e-01
-5691, 5.384171e-02, -1.122262e-02, 3.050005e-01
-5692, -1.983693e-02, 5.125899e-02, 4.946093e-01
-5693, -1.485503e-02, 5.288264e-02, 4.948797e-01
-5694, 4.891588e-02, 2.513975e-02, 1.554920e-02
-5695, 4.969077e-02, 2.347750e-02, 9.733473e-03
-5696, 4.703627e-02, 2.835577e-02, 1.029121e-02
-5697, 5.037162e-02, 2.206555e-02, 1.330933e-01
-5698, 5.209712e-02, 1.688188e-02, 1.303651e-01
-5699, 3.872700e-02, 3.901335e-02, 4.835578e-01
-5700, 4.066241e-02, 3.701299e-02, 4.893488e-01
-5701, 4.258227e-03, 5.479031e-02, 4.779074e-01
-5702, 9.588473e-03, 5.409033e-02, 4.774157e-01
-5703, 6.595735e-03, 5.460303e-02, 4.834815e-01
-5704, -5.474211e-02, -5.041159e-03, 3.886447e-02
-5705, -5.354559e-02, -1.136387e-02, 3.905772e-02
-5706, -5.397346e-02, -9.071039e-03, 2.943181e-02
-5707, -5.277695e-02, -1.539375e-02, 2.962506e-02
-5708, 4.207080e-02, -3.536454e-02, 4.538667e-01
-5709, 4.344890e-02, -3.372134e-02, 4.603773e-01
-5710, 4.617277e-02, -2.928532e-02, 4.555068e-01
-5711, 3.082931e-02, 4.553726e-02, 1.580298e-02
-5712, 2.787596e-02, 4.718319e-02, 1.053252e-02
-5713, 3.248422e-02, 4.436404e-02, 1.070146e-02
-5714, 2.114639e-02, 5.071531e-02, 1.501059e-02
-5715, 1.664196e-02, 5.238429e-02, 1.973077e-02
-5716, 2.198132e-02, 5.031153e-02, 2.211593e-02
-5717, 2.000452e-02, 5.093526e-02, 2.784736e-02
-5718, 2.489655e-02, 4.904190e-02, 2.745666e-02
-5719, 4.017510e-02, -3.748886e-02, 4.211297e-01
-5720, 3.305937e-02, -4.351878e-02, 4.265461e-01
-5721, 4.042666e-02, -3.719338e-02, 4.304566e-01
-5722, 4.625197e-02, -2.943057e-02, 4.683165e-01
-5723, 4.897583e-02, -2.499455e-02, 4.634461e-01
-5724, 2.180292e-02, -5.040785e-02, 2.486917e-02
-5725, 1.798967e-02, -5.196831e-02, 1.785177e-02
-5726, 1.584904e-02, -5.258977e-02, 2.530819e-02
-5727, -1.215037e-03, -5.407594e-02, 5.123247e-02
-5728, -7.949350e-03, -5.428580e-02, 5.960153e-02
-5729, -8.209273e-03, -5.426346e-02, 4.879901e-02
-5730, 1.943667e-02, -5.137315e-02, 4.209574e-02
-5731, 1.480200e-02, -5.294536e-02, 3.294578e-02
-5732, 2.075588e-02, -5.076344e-02, 3.250676e-02
-5733, -2.198929e-03, -5.487339e-02, 4.084043e-02
-5734, -5.272215e-03, -5.474556e-02, 3.243062e-02
-5735, 1.356951e-03, -5.498275e-02, 3.367633e-02
-5736, -1.716335e-03, -5.485492e-02, 2.526652e-02
-5737, 4.555767e-02, -3.060464e-02, 1.934514e-01
-5738, 4.922343e-02, -2.434681e-02, 2.012642e-01
-5739, 4.318458e-02, -3.335625e-02, 2.020880e-01
-5740, -2.987546e-02, -4.609401e-02, 1.076134e-02
-5741, -2.829493e-02, -4.715823e-02, 1.663973e-02
-5742, -2.542804e-02, -4.868545e-02, 1.123571e-02
-5743, -4.053371e-03, 5.482359e-02, 4.716954e-01
-5744, -6.942260e-03, 5.455212e-02, 4.774814e-01
-5745, -1.468989e-03, 5.482936e-02, 4.774221e-01
-5746, 4.743659e-02, 2.775598e-02, 1.188222e-01
-5747, 5.012448e-02, 2.246493e-02, 1.161633e-01
-5748, 4.755854e-02, 2.752316e-02, 1.127375e-01
-5749, 5.329296e-02, -1.339775e-02, 4.956744e-01
-5750, 5.425182e-02, -8.828189e-03, 4.955701e-01
-5751, 5.500000e-02, -1.347111e-17, 8.939749e-02
-5752, 5.449478e-02, -5.482521e-03, 9.223881e-02
-5753, 5.450585e-02, -5.422617e-03, 8.669683e-02
-5754, -4.316185e-02, 3.364971e-02, 6.150290e-02
-5755, -4.607164e-02, 3.001569e-02, 7.199909e-02
-5756, -3.686907e-02, 4.052898e-02, 5.979617e-02
-5757, -3.977885e-02, 3.689496e-02, 7.029236e-02
-5758, 5.247544e-02, -1.613770e-02, 1.899228e-01
-5759, 5.000441e-02, -2.251371e-02, 1.874134e-01
-5760, 4.938486e-02, -2.406057e-02, 1.954241e-01
-5761, 5.185589e-02, -1.768455e-02, 1.979336e-01
-5762, 2.979359e-04, 5.494002e-02, 4.264010e-01
-5763, -5.729407e-03, 5.404211e-02, 4.355865e-01
-5764, 2.626107e-02, 4.817098e-02, 1.533377e-02
-5765, 2.330773e-02, 4.981691e-02, 1.006331e-02
-5766, -1.383940e-02, -5.310411e-02, 1.618345e-02
-5767, -1.847066e-02, -5.180060e-02, 1.727016e-02
-5768, -1.400304e-02, -5.307147e-02, 2.336378e-02
-5769, -4.050467e-02, 3.718645e-02, 4.769728e-01
-5770, -3.982706e-02, 3.793022e-02, 4.697403e-01
-5771, -3.670752e-02, 4.080386e-02, 4.765901e-01
-5772, 3.493703e-02, 4.241022e-02, 4.841671e-01
-5773, 3.695476e-02, 4.073234e-02, 4.779369e-01
-5774, 1.639219e-02, 5.242257e-02, 3.490477e-01
-5775, 5.222644e-03, 5.391350e-02, 3.494135e-01
-5776, 1.690143e-02, 5.228470e-02, 3.612905e-01
-5777, 5.731887e-03, 5.377563e-02, 3.616564e-01
-5778, 5.500000e-02, -1.347111e-17, 1.105569e-01
-5779, 5.500000e-02, -1.347111e-17, 1.051894e-01
-5780, 5.458123e-02, 4.995059e-03, 1.079364e-01
-5781, 5.458123e-02, 4.995059e-03, 1.025689e-01
-5782, 4.767815e-02, 2.716883e-02, 2.059762e-01
-5783, 5.052785e-02, 2.163210e-02, 2.086977e-01
-5784, 5.052462e-02, 2.164039e-02, 2.030192e-01
-5785, -3.255763e-03, 5.488285e-02, 9.814571e-02
-5786, -1.288590e-02, 5.241642e-02, 9.316893e-02
-5787, -5.095649e-03, 5.467005e-02, 8.353965e-02
-5788, 4.884958e-02, 2.517088e-02, 3.850485e-02
-5789, 4.647293e-02, 2.926939e-02, 3.387460e-02
-5790, 4.937782e-02, 2.393426e-02, 3.256516e-02
-5791, 5.413654e-02, 9.689424e-03, 1.000367e-01
-5792, 5.457780e-02, 5.015362e-03, 9.702851e-02
-5793, 5.413310e-02, 9.709728e-03, 9.449629e-02
-5794, 4.739974e-02, -2.780636e-02, 4.744265e-01
-5795, 4.672363e-02, 2.859071e-02, 2.188905e-01
-5796, 5.042664e-02, 2.185945e-02, 2.215816e-01
-5797, 5.046141e-02, 2.177058e-02, 2.161825e-01
-5798, -5.256388e-02, 1.580030e-02, 6.273891e-02
-5799, -5.045491e-02, 2.008115e-02, 7.113413e-02
-5800, -5.375243e-02, 1.157630e-02, 7.102939e-02
-5801, 5.411086e-02, 9.793908e-03, 3.846491e-02
-5802, 5.460866e-02, 4.829844e-03, 4.199527e-02
-5803, 5.408729e-02, 9.936293e-03, 4.413023e-02
-5804, 5.458508e-02, 4.972230e-03, 4.766059e-02
-5805, 5.253381e-02, 1.545643e-02, 2.083287e-01
-5806, 5.238082e-02, 1.621393e-02, 2.135779e-01
-5807, 3.675005e-02, -4.049876e-02, 2.675152e-02
-5808, 3.896186e-02, -3.872183e-02, 2.027732e-02
-5809, 3.452901e-02, -4.272514e-02, 2.078546e-02
-5810, 4.338381e-02, -3.380419e-02, 4.735073e-01
-5811, 4.091559e-02, -3.656702e-02, 4.794003e-01
-5812, 4.453159e-02, -3.217998e-02, 4.796174e-01
-5813, 4.944167e-02, -2.408887e-02, 2.929897e-01
-5814, 5.011612e-02, -2.262208e-02, 2.981184e-01
-5815, -3.143097e-02, 4.479724e-02, 1.951873e-02
-5816, -2.736121e-02, 4.770191e-02, 2.251607e-02
-5817, -2.836347e-02, 4.707896e-02, 1.525345e-02
-5818, 5.409131e-02, 9.947385e-03, 3.662631e-01
-5819, 5.454264e-02, 5.218467e-03, 3.688730e-01
-5820, 5.408763e-02, 9.968213e-03, 3.607012e-01
-5821, 5.453895e-02, 5.239296e-03, 3.633111e-01
-5822, 5.500000e-02, -1.347111e-17, 1.698279e-02
-5823, 5.474761e-02, -3.543433e-03, 1.206771e-02
-5824, 5.450237e-02, -7.371526e-03, 1.510754e-02
-5825, 5.475476e-02, -3.828094e-03, 2.002263e-02
-5826, 3.833078e-02, -3.944046e-02, 3.065111e-01
-5827, 4.437138e-02, -3.127698e-02, 3.114516e-01
-5828, 3.927612e-02, -3.849402e-02, 3.156819e-01
-5829, -4.214666e-02, -3.527665e-02, 4.274069e-01
-5830, -3.736470e-02, -3.957695e-02, 4.380667e-01
-5831, -4.314376e-02, -3.410563e-02, 4.408889e-01
-5832, -3.617570e-02, -4.142725e-02, 6.206733e-03
-5833, -3.435567e-02, -4.289138e-02, 1.090389e-02
-5834, -3.825893e-02, -3.935397e-02, 1.092613e-02
-5835, 5.247698e-02, 1.589150e-02, 5.214218e-02
-5836, 5.273295e-02, 1.519764e-02, 4.619262e-02
-5837, -2.269960e-02, 4.967580e-02, 2.392217e-02
-5838, -2.680883e-02, 4.799615e-02, 3.004267e-02
-5839, -1.671769e-02, 5.239542e-02, 2.554753e-02
-5840, -2.082691e-02, 5.071578e-02, 3.166802e-02
-5841, 5.419201e-02, 9.374825e-03, 4.664594e-01
-5842, 5.424778e-02, 9.019473e-03, 4.718142e-01
-5843, 5.460892e-02, 4.828232e-03, 4.640057e-01
-5844, 5.466468e-02, 4.472880e-03, 4.693605e-01
-5845, 5.434565e-02, 8.454071e-03, 4.768594e-01
-5846, 5.466468e-02, 4.472880e-03, 4.748069e-01
-5847, 5.475889e-02, 3.795862e-03, 4.796110e-01
-5848, 5.443985e-02, 7.777053e-03, 4.816636e-01
-5849, 5.347699e-02, 1.239481e-02, 4.809320e-01
-5850, 5.285054e-02, 1.522392e-02, 4.852510e-01
-5851, 5.223311e-02, 1.711438e-02, 4.795086e-01
-5852, -3.819978e-02, 3.956960e-02, 9.096213e-02
-5853, -3.400494e-02, 4.296367e-02, 7.916609e-02
-5854, 4.943962e-02, 2.397060e-02, 4.897686e-01
-5855, 5.156419e-02, 1.877767e-02, 4.900456e-01
-5856, 5.094675e-02, 2.066813e-02, 4.843031e-01
-5857, 4.804947e-02, -2.675823e-02, 3.516916e-01
-5858, 4.884683e-02, -2.515899e-02, 3.465200e-01
-5859, 5.123531e-02, -1.850326e-02, 3.517308e-01
-5860, 4.167888e-02, -3.572008e-02, 9.750205e-02
-5861, 4.327072e-02, -3.394018e-02, 1.041989e-01
-5862, 4.627583e-02, -2.925551e-02, 9.929419e-02
-5863, -5.435890e-02, -8.183862e-03, 4.600036e-02
-5864, -5.432310e-02, -8.469190e-03, 5.842002e-02
-5865, -5.250067e-02, -1.555232e-02, 4.886829e-02
-5866, -1.421536e-02, 5.254802e-02, 2.509481e-01
-5867, -1.770413e-02, 5.063840e-02, 2.646097e-01
-5868, -3.129284e-02, 4.521267e-02, 2.563567e-01
-5869, -2.780407e-02, 4.712229e-02, 2.426952e-01
-5870, -4.728130e-02, -2.809533e-02, 4.897507e-01
-5871, -4.947562e-02, -2.349540e-02, 4.896174e-01
-5872, -4.841884e-02, -2.599061e-02, 4.840441e-01
-5873, -5.061315e-02, -2.139068e-02, 4.839108e-01
-5874, -1.188519e-02, 5.369673e-02, 1.159558e-02
-5875, -8.912886e-03, 5.413093e-02, 1.759975e-02
-5876, -1.415892e-02, 5.311095e-02, 1.759413e-02
-5877, 3.841723e-02, 3.929497e-02, 4.947966e-01
-5878, -5.471145e-02, -1.688115e-03, 4.763434e-02
-5879, -5.467565e-02, -1.973442e-03, 6.005400e-02
-5880, -5.462786e-02, 6.132989e-03, 5.089084e-02
-5881, 1.668965e-03, 5.477320e-02, 1.623419e-02
-5882, -1.235122e-03, 5.496518e-02, 1.097809e-02
-5883, 4.011270e-03, 5.475542e-02, 1.049475e-02
-5884, 6.915357e-03, 5.456344e-02, 1.575085e-02
-5885, 4.982740e-02, -2.321067e-02, 3.049197e-01
-5886, 5.237189e-02, -1.599785e-02, 3.021507e-01
-5887, 1.999945e-02, 5.121041e-02, 4.779742e-01
-5888, 1.490986e-02, 5.283779e-02, 4.777787e-01
-5889, 1.706572e-02, 5.227014e-02, 4.837667e-01
-5890, 1.116742e-02, 5.369240e-02, 4.638625e-01
-5891, 1.366306e-02, 5.324337e-02, 4.705439e-01
-5892, 1.761691e-02, 5.206736e-02, 4.636054e-01
-5893, 5.278408e-02, -1.491428e-02, 4.759832e-01
-5894, 5.394427e-02, -1.069887e-02, 4.717175e-01
-5895, 4.903623e-02, -2.472770e-02, 4.757880e-01
-5896, 5.100032e-02, -2.055460e-02, 4.749646e-01
-5897, 5.118568e-02, 2.002885e-02, 1.483497e-02
-5898, 5.041079e-02, 2.169111e-02, 2.065070e-02
-5899, 5.244636e-02, 1.650042e-02, 1.974277e-02
-5900, 5.500000e-02, -1.347111e-17, 7.766056e-02
-5901, 5.500000e-02, -1.347111e-17, 8.352902e-02
-5902, 5.450585e-02, -5.422617e-03, 8.082837e-02
-5903, 5.500000e-02, -1.347111e-17, 1.178177e-02
-5904, 7.092837e-03, 5.453936e-02, 4.707343e-01
-5905, 1.114897e-02, 5.300032e-02, 4.311411e-01
-5906, 1.646999e-02, 5.226449e-02, 4.384029e-01
-5907, -4.794904e-02, -2.607600e-02, 4.486177e-01
-5908, -5.106113e-02, -2.043727e-02, 4.544359e-01
-5909, -5.141372e-02, -1.948570e-02, 4.447966e-01
-5910, -8.364990e-03, 5.433143e-02, 3.161113e-02
-5911, -1.106051e-02, 5.366165e-02, 2.379365e-02
-5912, -5.814478e-03, 5.468164e-02, 2.379927e-02
-5913, 5.384171e-02, -1.122264e-02, 2.993060e-01
-5914, -5.328117e-02, -1.361094e-02, 4.770777e-01
-5915, 4.267980e-02, -3.467936e-02, 4.848898e-01
-5916, 4.384136e-02, -3.310310e-02, 4.904985e-01
-5917, 4.569315e-02, -3.060372e-02, 4.852261e-01
-5918, 4.926771e-02, -2.444311e-02, 3.955497e-01
-5919, 4.435966e-02, -3.164234e-02, 3.997575e-01
-5920, 4.969706e-02, -2.352079e-02, 4.038863e-01
-5921, 4.914527e-02, -2.469282e-02, 3.100683e-01
-5922, 5.168976e-02, -1.748000e-02, 3.072994e-01
-5923, 5.500000e-02, -1.347111e-17, 5.557286e-02
-5924, 5.500000e-02, -1.347111e-17, 6.108357e-02
-5925, 5.451502e-02, -5.372499e-03, 5.856157e-02
-5926, -4.155671e-02, 3.594900e-02, 5.260044e-02
-5927, -4.136971e-02, -3.467636e-02, 3.881791e-01
-5928, -3.361318e-02, -4.346946e-02, 3.920417e-01
-5929, 2.250645e-02, 5.003231e-02, 4.570061e-01
-5930, 2.846831e-02, 4.700717e-02, 4.583584e-01
-5931, 2.354221e-02, 4.943313e-02, 4.654380e-01
-5932, 4.542469e-02, -3.042650e-02, 2.650415e-01
-5933, 3.989317e-02, -3.778350e-02, 2.643853e-01
-5934, 4.280186e-02, -3.450430e-02, 2.575215e-01
-5935, 4.393815e-02, -3.243638e-02, 3.941057e-01
-5936, 3.946263e-02, -3.827839e-02, 3.988146e-01
-5937, -5.354493e-02, 1.002825e-02, 9.098319e-02
-5938, -5.257723e-02, 1.576498e-02, 7.986491e-02
-5939, 5.263086e-02, 1.553678e-02, 4.542978e-01
-5940, 5.286941e-02, 1.428286e-02, 4.595848e-01
-5941, 5.124780e-02, 1.992073e-02, 4.606363e-01
-5942, 4.730277e-02, 2.787321e-02, 8.187461e-02
-5943, 4.380403e-02, 3.306172e-02, 8.937417e-02
-5944, 4.245900e-02, 3.448278e-02, 8.043751e-02
-5945, 4.745341e-02, 2.754679e-02, 2.243587e-01
-5946, 5.038375e-02, 2.196793e-02, 2.272364e-01
-5947, 4.716398e-02, 2.812602e-02, 2.312020e-01
-5948, 5.009432e-02, 2.254716e-02, 2.340797e-01
-5949, 4.741329e-02, 2.714770e-02, 9.262122e-02
-5950, 5.103079e-02, 2.050650e-02, 8.958275e-02
-5951, 5.110825e-02, 2.030608e-02, 9.493992e-02
-5952, 4.653392e-02, 2.897614e-02, 7.607783e-02
-5953, 4.169015e-02, 3.558572e-02, 7.464073e-02
-5954, 4.663270e-02, 2.877845e-02, 6.990844e-02
-5955, 3.324121e-02, 4.317896e-02, 4.615078e-02
-5956, 3.946180e-02, 3.831064e-02, 4.954338e-02
-5957, 4.012683e-02, 3.760897e-02, 4.270691e-02
-5958, 4.622474e-02, 2.945291e-02, 2.367106e-01
-5959, -4.271638e-02, 3.461676e-02, 4.899611e-01
-5960, -4.427680e-02, 3.259827e-02, 4.950178e-01
-5961, -4.565501e-02, 3.037384e-02, 4.904236e-01
-5962, -3.097316e-02, 4.525216e-02, 4.225744e-01
-5963, -2.642252e-02, 4.823182e-02, 4.321030e-01
-5964, -2.031121e-02, 5.066627e-02, 4.242764e-01
-5965, -5.254156e-02, -1.614118e-02, 4.834834e-01
-5966, -5.166894e-02, -1.883950e-02, 4.893426e-01
-5967, -5.304972e-02, -1.395135e-02, 4.893162e-01
-5968, -3.833998e-02, -3.873849e-02, 1.340040e-01
-5969, -4.604100e-02, -2.950392e-02, 1.364008e-01
-5970, -4.302448e-02, -3.426101e-02, 1.252092e-01
-5971, 4.692958e-02, 2.858690e-02, 4.895454e-01
-5972, 4.794743e-02, 2.693945e-02, 4.946986e-01
-5973, 4.317896e-02, 3.399938e-02, 2.158439e-01
-5974, 4.270422e-02, 3.453612e-02, 2.221645e-01
-5975, 5.393027e-02, -1.079226e-02, 2.442917e-01
-5976, 5.380047e-02, -1.141858e-02, 2.384587e-01
-5977, 5.216710e-02, -1.652571e-02, 2.411928e-01
-5978, -5.275955e-02, 1.302772e-02, 3.550872e-01
-5979, -5.190130e-02, 1.772445e-02, 3.655437e-01
-5980, -5.477447e-02, 4.928517e-03, 3.677806e-01
-5981, -5.391622e-02, 9.625246e-03, 3.782370e-01
-5982, 1.882718e-02, 5.131049e-02, 3.397679e-02
-5983, 2.663783e-02, 4.809299e-02, 3.680818e-02
-5984, 5.449120e-02, -5.018094e-03, 2.415961e-01
-5985, -1.414820e-02, -5.275126e-02, 2.338702e-01
-5986, -2.430818e-02, -4.903707e-02, 2.283372e-01
-5987, -2.604823e-02, 4.789887e-02, 2.843844e-01
-5988, -1.312449e-02, 5.311823e-02, 2.942374e-01
-5989, -2.589174e-02, 4.800943e-02, 3.010361e-01
-5990, -4.094084e-02, 3.671032e-02, 4.949433e-01
-5991, 5.119407e-02, -1.845136e-02, 2.138120e-01
-5992, 4.940120e-02, -2.403110e-02, 2.070157e-01
-5993, 4.849319e-02, -2.594012e-02, 2.146826e-01
-5994, -3.459722e-02, 4.275137e-02, 4.325870e-01
-5995, -3.004659e-02, 4.573102e-02, 4.421156e-01
-5996, 5.220499e-02, 1.695973e-02, 1.970925e-01
-5997, 4.894595e-02, 2.446850e-02, 1.967062e-01
-5998, 5.210408e-02, 1.721516e-02, 1.915597e-01
-5999, 4.884504e-02, 2.472393e-02, 1.911733e-01
-6000, -4.078438e-02, -3.674612e-02, 4.788861e-01
-6001, -3.747042e-02, -4.021675e-02, 4.796573e-01
-6002, -3.762936e-02, -4.007831e-02, 4.726887e-01
-6003, -3.596116e-02, -4.090923e-02, 2.076752e-01
-6004, -2.515132e-02, -4.869528e-02, 2.145486e-01
-6005, -3.499172e-02, -4.195720e-02, 2.220925e-01
-6006, 3.649278e-02, 4.114428e-02, 3.030877e-01
-6007, 4.183977e-02, 3.472828e-02, 3.035796e-01
-6008, 4.084289e-02, 3.623272e-02, 3.088117e-01
-6009, 3.360744e-02, 4.337119e-02, 1.222024e-01
-6010, 2.521149e-02, 4.733101e-02, 1.151356e-01
-6011, 1.630902e-02, 5.251777e-02, 1.200488e-01
-6012, 2.470497e-02, 4.855796e-02, 1.271156e-01
-6013, 4.799419e-02, 2.633437e-02, 3.315612e-01
-6014, 4.712811e-02, 2.756070e-02, 3.369478e-01
-6015, 5.092971e-02, 2.075948e-02, 3.349042e-01
-6016, 3.934457e-02, -3.841761e-02, 1.641035e-01
-6017, 3.995887e-02, -3.773712e-02, 1.698206e-01
-6018, 3.240806e-02, -4.362323e-02, 1.687778e-01
-6019, 4.988093e-02, -2.292212e-02, 3.577047e-01
-6020, 4.555239e-02, -3.047898e-02, 3.590113e-01
-6021, 3.394545e-02, 4.321127e-02, 3.127789e-01
-6022, 4.586467e-02, -2.983381e-02, 7.781552e-02
-6023, 4.260177e-02, -3.477495e-02, 7.422049e-02
-6024, 4.647563e-02, -2.838402e-02, 6.857485e-02
-6025, -3.973102e-02, -3.799369e-02, 4.719400e-03
-6026, 5.389663e-02, -1.093318e-02, 4.496490e-01
-6027, 5.447654e-02, -5.579759e-03, 4.523661e-01
-6028, 5.447654e-02, -5.579759e-03, 4.463646e-01
-6029, 5.074907e-02, 2.120215e-02, 3.404927e-01
-6030, 3.445647e-03, 5.478741e-02, 4.892379e-01
-6031, 8.867815e-03, 5.421835e-02, 4.894896e-01
-6032, 4.127728e-02, -3.622099e-02, 8.048423e-02
-6033, 4.566909e-02, -3.021552e-02, 8.362828e-02
-6034, 2.502209e-02, -4.893047e-02, 9.241675e-02
-6035, 1.269629e-02, -5.264214e-02, 9.870485e-02
-6036, 1.581995e-02, -5.223761e-02, 8.598841e-02
-6037, 3.147528e-02, -4.503404e-02, 4.852619e-01
-6038, 3.534269e-02, -4.209676e-02, 4.847787e-01
-6039, 3.328079e-02, -4.378520e-02, 4.903527e-01
-6040, -5.235268e-02, -1.455702e-02, 6.089065e-02
-6041, -5.053025e-02, -2.164015e-02, 5.133892e-02
-6042, 4.203890e-02, 3.501239e-02, 4.035488e-01
-6043, 4.282802e-02, 3.379869e-02, 3.981409e-01
-6044, 3.730045e-02, 4.040837e-02, 3.984104e-01
-6045, 5.422216e-02, 6.787158e-03, 4.891986e-01
-6046, 5.327667e-02, 1.359747e-02, 4.902512e-01
-6047, 5.390312e-02, 1.076835e-02, 4.859321e-01
-6048, -2.397749e-02, -4.939314e-02, 4.269589e-01
-6049, -3.467494e-02, -4.177069e-02, 4.235946e-01
-6050, -2.989299e-02, -4.607099e-02, 4.342544e-01
-6051, 5.476576e-02, 3.741581e-03, 1.471571e-02
-6052, 5.476576e-02, 3.741581e-03, 1.991674e-02
-6053, 2.504901e-02, -4.877026e-02, 4.299571e-01
-6054, 2.620701e-02, -4.826307e-02, 4.203508e-01
-6055, -3.472663e-03, 5.489013e-02, 1.318059e-01
-6056, 5.809521e-03, 5.404485e-02, 1.389694e-01
-6057, 6.104664e-03, 5.396511e-02, 1.251983e-01
-6058, 1.519271e-02, 5.282201e-02, 1.322698e-01
-6059, -4.714978e-02, 2.825502e-02, 4.954058e-01
-6060, 5.337912e-02, 1.296021e-02, 4.758867e-01
-6061, 5.192765e-02, 1.809691e-02, 4.739450e-01
-6062, 5.475889e-02, 3.795862e-03, 4.849301e-01
-6063, 4.492067e-02, -3.126153e-02, 4.344343e-01
-6064, 4.927514e-02, -2.435020e-02, 4.381705e-01
-6065, 4.944613e-02, -2.403093e-02, 4.441912e-01
-6066, 4.530130e-02, -3.091197e-02, 4.404439e-01
-6067, 2.326722e-02, 4.896800e-02, 1.902159e-01
-6068, 1.581033e-02, 5.267840e-02, 1.972576e-01
-6069, 1.549047e-02, 5.277305e-02, 1.888376e-01
-6070, -5.034593e-02, -1.978675e-02, 6.951109e-02
-6071, -5.317013e-02, -1.356325e-02, 7.859109e-02
-6072, -5.436543e-02, -8.236542e-03, 6.701431e-02
-6073, 3.784878e-02, -3.986938e-02, 1.049256e-01
-6074, 3.242919e-02, -4.373785e-02, 9.604652e-02
-6075, 1.585539e-02, -5.221780e-02, 5.237787e-02
-6076, 2.467635e-02, -4.903125e-02, 4.796989e-02
-6077, 5.246870e-02, -1.594407e-02, 5.815485e-02
-6078, 5.253318e-02, -1.563311e-02, 5.262780e-02
-6079, 5.050205e-02, -2.165117e-02, 5.447212e-02
-6080, 3.589255e-02, 4.156006e-02, 7.078090e-02
-6081, 3.590554e-02, 4.154995e-02, 8.075407e-02
-6082, 2.943850e-02, 4.611941e-02, 6.407455e-02
-6083, 2.945149e-02, 4.610930e-02, 7.404772e-02
-6084, 5.006226e-02, -2.258840e-02, 8.371621e-02
-6085, 4.962431e-02, -2.364080e-02, 8.967501e-02
-6086, 5.113020e-02, 2.025307e-02, 9.964681e-02
-6087, 5.257656e-02, 1.540927e-02, 9.717084e-02
-6088, 5.252841e-02, 1.565449e-02, 1.026768e-01
-6089, 2.681437e-02, -4.784727e-02, 7.818141e-02
-6090, 5.235868e-02, 1.623889e-02, 1.249561e-01
-6091, 2.791495e-02, -4.673324e-02, 1.461220e-01
-6092, 2.362184e-02, -4.955589e-02, 1.540851e-01
-6093, 3.703010e-02, -4.064117e-02, 1.420018e-01
-6094, 3.296753e-02, -4.348627e-02, 1.500713e-01
-6095, 5.025784e-02, -2.220669e-02, 7.790345e-02
-6096, -5.410972e-02, 4.997125e-03, 7.884051e-02
-6097, 5.500000e-02, -1.347111e-17, 4.435118e-01
-6098, 5.500000e-02, -1.347111e-17, 4.495133e-01
-6099, -2.013328e-02, 5.106531e-02, 4.829863e-01
-6100, -2.500785e-02, 4.896615e-02, 4.826628e-01
-6101, -2.250299e-02, 5.017259e-02, 4.887615e-01
-6102, 5.242071e-02, -1.614978e-02, 2.657962e-01
-6103, 5.405416e-02, -9.997935e-03, 2.663934e-01
-6104, -3.114999e-03, -5.478062e-02, 2.267785e-01
-6105, -1.743484e-03, -5.474077e-02, 2.403601e-01
-6106, -4.244839e-02, 3.433534e-02, 2.086410e-01
-6107, -3.837253e-02, 3.746534e-02, 1.970975e-01
-6108, -4.753042e-02, 2.754517e-02, 1.978140e-01
-6109, 5.045456e-02, -2.175245e-02, 2.570066e-01
-6110, 5.029336e-02, -2.207477e-02, 2.629634e-01
-6111, 5.243388e-02, -1.609013e-02, 2.601361e-01
-6112, -5.411290e-02, 8.847396e-03, 6.251415e-02
-6113, -5.431517e-02, 7.554667e-04, 6.856923e-02
-6114, 4.178008e-02, 3.526685e-02, 3.846398e-01
-6115, 4.302007e-02, 3.402641e-02, 3.773413e-01
-6116, 5.177283e-02, 1.848466e-02, 3.100301e-02
-6117, 5.151786e-02, 1.923418e-02, 3.669188e-02
-6118, 4.954172e-02, -2.388480e-02, 2.501669e-01
-6119, 5.384023e-02, -1.054383e-02, 4.910293e-01
-6120, 5.475096e-02, -3.857512e-03, 4.894931e-01
-6121, 5.446035e-02, -7.658286e-03, 4.866809e-01
-6122, 5.288137e-02, -1.511339e-02, 4.911337e-01
-6123, 2.703991e-02, -4.787763e-02, 1.515737e-02
-6124, 3.142239e-02, -4.500164e-02, 1.454537e-02
-6125, 2.924137e-02, -4.639660e-02, 1.029081e-02
-6126, 3.362385e-02, -4.352060e-02, 9.678808e-03
-6127, 4.645547e-02, 2.926906e-02, 3.127426e-01
-6128, 4.745235e-02, 2.776462e-02, 3.075105e-01
-6129, -4.505612e-02, -3.154240e-02, 4.733333e-01
-6130, -4.353449e-02, -3.352355e-02, 4.674726e-01
-6131, -4.636805e-02, -2.950889e-02, 4.660473e-01
-6132, -8.027844e-03, -5.435312e-02, 4.946570e-01
-6133, 3.015756e-02, -4.495673e-02, 3.201947e-01
-6134, 3.937413e-02, -3.839652e-02, 3.229152e-01
-6135, 3.005955e-02, -4.505423e-02, 3.129615e-01
-6136, -3.971162e-02, -3.754342e-02, 4.576145e-01
-6137, -4.316011e-02, -3.404729e-02, 4.592494e-01
-6138, -4.348185e-02, -3.365600e-02, 4.508514e-01
-6139, -3.120610e-03, -5.487495e-02, 4.947816e-01
-6140, 5.475096e-02, -3.857512e-03, 4.955701e-01
-6141, 1.326330e-02, -5.288162e-02, 3.222378e-01
-6142, 2.469059e-02, -4.899818e-02, 3.246780e-01
-6143, 2.199760e-02, -5.039853e-02, 3.151185e-01
-6144, 5.454084e-02, 5.228631e-03, 6.371453e-02
-6145, 5.395186e-02, 1.062328e-02, 6.107612e-02
-6146, 5.454084e-02, 5.228631e-03, 5.820381e-02
-6147, 3.521339e-02, -4.221193e-02, 4.949791e-01
-6148, 5.397385e-02, -1.053573e-02, 5.531545e-02
-6149, 5.396146e-02, -1.060427e-02, 6.097950e-02
-6150, 3.299202e-02, -4.280807e-02, 2.579395e-01
-6151, -4.708361e-02, -2.842711e-02, 7.433163e-02
-6152, -4.168131e-02, -3.542553e-02, 6.989609e-02
-6153, -3.906853e-02, -3.721099e-02, 8.111229e-02
-6154, 5.391474e-02, -1.082688e-02, 8.358752e-02
-6155, 3.181380e-02, -4.454054e-02, 3.687193e-01
-6156, 4.022156e-02, -3.719855e-02, 3.674168e-01
-6157, 3.868320e-02, -3.900509e-02, 3.754077e-01
-6158, 5.453072e-02, 5.285496e-03, 6.931362e-02
-6159, 5.394174e-02, 1.068015e-02, 6.667522e-02
-6160, 1.224413e-02, -5.361935e-02, 4.952784e-01
-6161, 5.449120e-02, -5.018094e-03, 2.357725e-01
-6162, 5.500000e-02, -1.347111e-17, 4.878460e-01
-6163, 5.452741e-02, -5.303957e-03, 5.289752e-02
-6164, -3.559070e-02, -4.192991e-02, 4.852065e-01
-6165, -3.359432e-02, -4.346247e-02, 4.792516e-01
-6166, 4.276137e-02, 3.447245e-02, 6.702849e-02
-6167, 4.527762e-02, -3.097074e-02, 3.708488e-01
-6168, 1.158115e-02, 5.376535e-02, 4.634240e-03
-6169, 3.944063e-02, -3.808948e-02, 1.116224e-01
-6170, 5.500000e-02, -1.347111e-17, 2.721434e-01
-6171, 5.500000e-02, -1.347111e-17, 2.784536e-01
-6172, 3.933861e-02, -3.817116e-02, 1.333392e-01
-6173, 4.029546e-02, -3.730424e-02, 1.260907e-01
-6174, 4.486381e-02, -3.140691e-02, 1.307443e-01
-6175, 7.438211e-03, 5.385579e-02, 9.262780e-02
-6176, 5.017199e-02, 2.237168e-02, 3.719766e-01
-6177, 5.232895e-02, 1.649284e-02, 3.746138e-01
-6178, 5.226667e-02, 1.665257e-02, 3.688998e-01
-6179, 5.468558e-02, 4.332016e-03, 2.482379e-02
-6180, 5.500000e-02, -1.347111e-17, 2.218382e-02
-6181, 5.389016e-02, 1.089284e-02, 3.716457e-01
-6182, 9.912744e-03, 5.380997e-02, 5.897157e-02
-6183, -6.574441e-04, 5.483968e-02, 4.904443e-02
-6184, -2.600323e-03, 5.461835e-02, 6.340251e-02
-6185, 5.452953e-02, 5.292134e-03, 3.355683e-01
-6186, 5.452953e-02, 5.292134e-03, 3.409358e-01
-6187, 5.416554e-02, 9.542696e-03, 3.383770e-01
-6188, 5.462371e-02, -4.736667e-03, 2.508923e-02
-6189, 5.432239e-02, -8.457500e-03, 2.153582e-02
-6190, 5.373579e-02, 1.154171e-02, 3.439328e-01
-6191, 5.370901e-02, 1.168902e-02, 3.495776e-01
-6192, 5.450275e-02, 5.439450e-03, 3.465805e-01
-6193, 2.644913e-02, -4.787563e-02, 3.904536e-02
-6194, 3.725056e-02, 4.012889e-02, 8.969073e-02
-6195, 5.433946e-02, -6.260675e-03, 3.799971e-01
-6196, 5.364546e-02, -1.211030e-02, 3.829471e-01
-6197, 5.433946e-02, -6.260675e-03, 3.856199e-01
-6198, -4.073394e-02, 3.615889e-02, 4.416191e-01
-6199, -4.721555e-02, 2.793841e-02, 4.437655e-01
-6200, -4.546787e-02, 3.094618e-02, 4.324105e-01
-6201, 5.183850e-02, -1.746596e-02, 6.379025e-02
-6202, 3.992494e-02, -3.775870e-02, 4.737903e-01
-6203, -9.052734e-03, 5.346078e-02, 3.923941e-01
-6204, -1.775368e-03, 5.496046e-02, 3.833209e-01
-6205, -2.237749e-02, 5.012771e-02, 3.883226e-01
-6206, -1.505214e-02, 5.217438e-02, 3.795694e-01
-6207, 4.244378e-02, -3.497481e-02, 4.949413e-01
-6208, 4.522740e-02, -3.129620e-02, 4.955572e-01
-6209, 5.384785e-02, -1.119777e-02, 4.000160e-01
-6210, 5.373812e-02, -1.170597e-02, 3.945259e-01
-6211, 5.435747e-02, -6.175691e-03, 3.973831e-01
-6212, 5.188994e-02, -1.742003e-02, 9.239440e-02
-6213, 5.391131e-02, -1.085216e-02, 9.465622e-02
-6214, 5.243068e-02, -1.610310e-02, 9.913299e-02
-6215, 4.314164e-02, 3.401807e-02, 9.512389e-02
-6216, -2.973812e-02, -4.615113e-02, 4.544693e-01
-6217, -3.444508e-02, -4.283197e-02, 4.544360e-01
-6218, -3.243625e-02, -4.441588e-02, 4.448507e-01
-6219, 2.630393e-02, 4.830212e-02, 4.488743e-01
-6220, 1.875054e-02, 5.116329e-02, 4.481594e-01
-6221, 1.108140e-03, 5.497469e-02, 4.836638e-01
-6222, -4.200123e-02, -3.532875e-02, 2.488745e-02
-6223, -4.288766e-02, -3.402329e-02, 3.237446e-02
-6224, -4.625157e-02, -2.961708e-02, 2.494764e-02
-6225, -4.713800e-02, -2.831162e-02, 3.243465e-02
-6226, 5.315360e-02, -1.373120e-02, 2.261352e-02
-6227, 5.333357e-02, -1.264523e-02, 1.618524e-02
-6228, 3.479524e-02, 4.259392e-02, 2.962541e-02
-6229, 3.112018e-02, 4.514413e-02, 3.885104e-02
-6230, 3.800580e-02, 3.957414e-02, 3.540716e-02
-6231, -4.946827e-02, 2.393964e-02, 4.951036e-01
-6232, -4.842341e-02, 2.607676e-02, 4.905095e-01
-6233, -3.252128e-02, 4.366058e-02, 9.850931e-02
-6234, -2.378570e-02, 4.955709e-02, 9.663981e-02
-6235, -2.555000e-02, 4.870519e-02, 1.101640e-01
-6236, 4.592995e-02, 3.019333e-02, 4.010933e-02
-6237, 4.361179e-02, 3.298482e-02, 4.748679e-02
-6238, 4.244499e-02, 3.481748e-02, 3.532945e-02
-6239, 2.992463e-02, -4.563089e-02, 3.788040e-01
-6240, -2.946420e-02, 4.546612e-02, 8.909263e-02
-6241, -2.073519e-02, 5.090874e-02, 8.618403e-02
-6242, 5.500000e-02, -1.347111e-17, 2.658332e-01
-6243, 1.305807e-02, -5.282327e-02, 2.771680e-01
-6244, 2.382271e-02, -4.951962e-02, 2.677737e-01
-6245, 2.523868e-02, -4.872076e-02, 2.795275e-01
-6246, -5.165322e-02, -1.876397e-02, 9.515546e-02
-6247, -4.683907e-02, -2.790232e-02, 1.013924e-01
-6248, -4.990781e-02, -2.220360e-02, 8.341163e-02
-6249, -4.509366e-02, -3.134196e-02, 8.964859e-02
-6250, 6.372786e-03, 5.367953e-02, 1.034332e-01
-6251, -6.359767e-03, 5.459771e-02, 1.095239e-01
-6252, -9.086642e-03, -5.404846e-02, 3.971203e-02
-6253, -1.592421e-02, -5.261409e-02, 4.142335e-02
-6254, -1.504684e-02, -5.282910e-02, 5.051034e-02
-6255, 1.596356e-02, -5.144330e-02, 2.609363e-01
-6256, 5.198917e-03, -5.474695e-02, 2.703306e-01
-6257, 1.180965e-02, -5.353494e-02, 4.187664e-02
-6258, 8.228368e-03, -5.437960e-02, 5.215876e-02
-6259, -2.908941e-02, -4.656806e-02, 3.781394e-02
-6260, -3.431617e-02, -4.280668e-02, 3.822884e-02
-6261, -2.976743e-02, -4.618865e-02, 4.594502e-02
-6262, -2.527593e-02, 4.840629e-02, 7.625749e-02
-6263, -5.363113e-02, -2.756483e-03, 1.779935e-01
-6264, -5.425973e-02, 8.907187e-03, 1.887235e-01
-6265, -5.383915e-02, 1.120502e-02, 1.740777e-01
-6266, -5.484876e-02, 7.001506e-04, 2.168869e-01
-6267, -5.464110e-02, 2.567176e-03, 2.030274e-01
-6268, -5.347127e-02, -1.096340e-02, 2.071846e-01
-6269, -4.516252e-04, -5.444789e-02, 3.614052e-01
-6270, 5.500000e-02, -1.347111e-17, 3.883028e-01
-6271, 5.435747e-02, -6.175691e-03, 3.916043e-01
-6272, -7.900602e-03, -5.326650e-02, 2.641061e-01
-6273, -1.075562e-02, -5.332466e-02, 2.747535e-01
-6274, -2.102509e-02, -5.069809e-02, 2.662617e-01
-6275, 5.049046e-02, 2.177869e-02, 1.386034e-01
-6276, 4.636653e-02, 2.889665e-02, 1.358175e-01
-6277, 2.343902e-03, -5.480511e-02, 2.809780e-01
-6278, -3.581322e-02, -4.173542e-02, 4.947276e-01
-6279, -3.934780e-02, -3.841296e-02, 4.952805e-01
-6280, -3.751499e-02, -4.007967e-02, 4.900081e-01
-6281, 2.851124e-02, -4.558950e-02, 2.224822e-01
-6282, -5.069129e-02, -1.972984e-02, 3.555204e-01
-6283, -4.646926e-02, -2.938265e-02, 3.513279e-01
-6284, -5.110467e-02, -1.770459e-02, 3.449355e-01
-6285, -4.947575e-02, 2.392229e-02, 4.856420e-01
-6286, -4.730772e-02, 2.791560e-02, 4.855231e-01
-6287, -3.153089e-02, -4.504679e-02, 7.745537e-02
-6288, -3.217686e-02, -4.460367e-02, 8.949058e-02
-6289, 3.504578e-03, -5.488745e-02, 4.003469e-01
-6290, -3.030815e-04, -5.481780e-02, 3.890856e-01
-6291, 1.116121e-02, -5.321263e-02, 3.959524e-01
-6292, -1.381138e-02, -5.304059e-02, 3.650313e-01
-6293, 3.031288e-02, 4.554278e-02, 2.758255e-02
-6294, 2.499860e-02, -4.884770e-02, 4.781851e-01
-6295, 3.008417e-02, -4.601568e-02, 4.726823e-01
-6296, -5.480861e-02, 3.942364e-03, 9.947104e-02
-6297, -5.440732e-02, 7.941688e-03, 1.129656e-01
-6298, -5.245701e-02, 1.463554e-02, 1.006703e-01
-6299, -5.401250e-02, -9.096494e-03, 1.922974e-01
-6300, 4.795308e-03, -5.468587e-02, 4.327389e-02
-6301, 4.863947e-02, 2.529229e-02, 1.024332e-01
-6302, 5.120955e-02, 2.004320e-02, 1.052685e-01
-6303, -5.307883e-02, 1.308589e-02, 5.111560e-02
-6304, -4.511060e-02, 3.132723e-02, 4.219927e-02
-6305, -4.696746e-02, 2.786870e-02, 5.183247e-02
-6306, 3.287628e-02, -4.369560e-02, 4.339129e-01
-6307, 4.024356e-02, -3.737019e-02, 4.378234e-01
-6308, 1.985974e-02, 5.128871e-02, 3.978555e-01
-6309, 2.800966e-02, 4.607671e-02, 4.029543e-01
-6310, 2.005913e-02, 5.120941e-02, 4.076503e-01
-6311, -4.769906e-02, 2.728346e-02, 3.328918e-02
-6312, -4.955592e-02, 2.382492e-02, 4.292237e-02
-6313, 2.915592e-02, -4.606071e-02, 1.321406e-01
-6314, 3.011277e-02, -4.519379e-02, 1.248920e-01
-6315, 2.043885e-02, -5.104958e-02, 2.868121e-01
-6316, 9.724686e-03, -5.303142e-02, 2.906222e-01
-6317, 2.004270e-02, -5.108409e-02, 4.899792e-01
-6318, 1.766072e-02, -5.208006e-02, 4.853515e-01
-6319, 1.489115e-02, -5.289628e-02, 4.898848e-01
-6320, -5.208095e-02, -1.731281e-02, 1.080241e-01
-6321, -5.369559e-02, -1.151860e-02, 1.193555e-01
-6322, -5.380564e-02, -4.799897e-03, 1.105345e-01
-6323, 6.985869e-03, -5.454166e-02, 4.947461e-01
-6324, 1.006661e-02, -5.402456e-02, 4.900246e-01
-6325, 5.379377e-02, 1.126612e-02, 2.720329e-01
-6326, 5.455730e-02, 5.134766e-03, 2.688843e-01
-6327, 5.406733e-02, -9.938285e-03, 2.607333e-01
-6328, 5.464841e-02, -4.579517e-03, 2.632482e-01
-6329, 5.443907e-02, -5.774171e-03, 2.525591e-01
-6330, 5.464841e-02, -4.579517e-03, 2.578807e-01
-6331, 5.500000e-02, -1.347111e-17, 2.550982e-01
-6332, 5.260714e-02, -1.445697e-02, 4.648684e-01
-6333, 5.443575e-02, -5.791092e-03, 3.686533e-01
-6334, 5.462741e-02, -4.713431e-03, 3.633667e-01
-6335, 5.500000e-02, -1.347111e-17, 3.660357e-01
-6336, -5.037067e-02, 2.003103e-02, 4.629282e-01
-6337, -5.315372e-02, 1.378806e-02, 4.632782e-01
-6338, -4.792564e-02, 2.695370e-02, 4.663055e-01
-6339, -5.070869e-02, 2.071073e-02, 4.666555e-01
-6340, -1.210265e-02, -5.326225e-02, 3.795784e-01
-6341, 1.257102e-03, -5.466955e-02, 3.759522e-01
-6342, -9.114112e-03, 5.389356e-02, 4.250383e-01
-6343, -8.294991e-03, -5.333191e-02, 3.908397e-01
-6344, -9.360688e-03, -5.294330e-02, 4.049665e-01
-6345, 2.465476e-02, -4.901027e-02, 3.726752e-01
-6346, 1.308740e-02, -5.291793e-02, 3.749735e-01
-6347, 2.261099e-02, -5.010577e-02, 3.826876e-01
-6348, 5.385799e-02, -1.113294e-02, 2.554117e-01
-6349, -5.182189e-02, -1.820077e-02, 4.343708e-01
-6350, -5.398236e-02, -8.468196e-03, 4.327952e-01
-6351, -5.286561e-02, -1.517313e-02, 4.220954e-01
-6352, 5.298083e-02, 1.475585e-02, 1.453917e-02
-6353, 5.343351e-02, 1.298439e-02, 9.272843e-03
-6354, -2.488959e-02, 4.904461e-02, 4.154982e-02
-6355, -4.865467e-02, -2.349799e-02, 4.263799e-01
-6356, -4.827797e-02, -2.397529e-02, 4.139503e-01
-6357, -4.176995e-02, -3.575395e-02, 4.149774e-01
-6358, 2.069826e-02, 5.095228e-02, 4.282941e-01
-6359, 9.847231e-03, 5.289198e-02, 4.235540e-01
-6360, -4.761095e-02, -2.652563e-02, 4.386552e-01
-6361, 3.336996e-02, -4.302102e-02, 3.373771e-01
-6362, 4.173860e-02, -3.573886e-02, 3.386337e-01
-6363, 3.725748e-02, -4.030849e-02, 3.457933e-01
-6364, -5.400927e-02, -9.837299e-03, 3.593183e-01
-6365, -5.411052e-02, -8.729348e-03, 3.482985e-01
-6366, -5.468634e-02, 1.987381e-04, 3.587355e-01
-6367, -5.478759e-02, 1.306690e-03, 3.477157e-01
-6368, -3.375994e-02, -4.324647e-02, 6.629904e-02
-6369, -3.248861e-02, -4.403584e-02, 5.636597e-02
-6370, -3.845032e-02, -3.921859e-02, 5.895266e-02
-6371, -8.344055e-03, 5.346243e-02, 4.050372e-01
-6372, -1.973519e-02, 5.133207e-02, 4.017388e-01
-6373, 5.392388e-02, -1.082337e-02, 2.499169e-01
-6374, 5.657174e-02, -8.132058e-03, 2.992607e-01
-6375, 5.723910e-02, -1.839515e-03, 2.966277e-01
-6376, 5.667962e-02, -7.606289e-03, 2.935563e-01
-6377, -4.871279e-02, -2.454028e-02, 4.669906e-01
-6378, -5.145051e-02, -1.942528e-02, 4.645856e-01
-6379, -4.910577e-02, -2.439390e-02, 4.636423e-01
-6380, -5.289199e-02, -1.385349e-02, 4.626988e-01
-6381, -5.324457e-02, -1.290192e-02, 4.530595e-01
-6382, -5.357419e-02, -9.753129e-03, 4.432210e-01
-6383, -4.460716e-02, 3.152604e-02, 4.725299e-01
-6384, -4.392956e-02, 3.226981e-02, 4.652973e-01
-6385, -3.568092e-02, 4.179629e-02, 4.890003e-01
-6386, -3.408919e-02, 4.316053e-02, 4.827559e-01
-6387, -3.829925e-02, 3.943962e-02, 4.828344e-01
-6388, -2.578638e-02, 4.858044e-02, 4.511171e-01
-6389, -2.351452e-02, 4.966933e-02, 4.605529e-01
-6390, -1.999109e-02, 5.092584e-02, 4.537709e-01
-6391, -1.845938e-02, -5.180510e-02, 3.914516e-01
-6392, 6.943956e-04, 5.497196e-02, 3.935205e-01
-6393, -3.735217e-02, 4.034626e-02, 1.089172e-01
-6394, -4.152054e-02, 3.565228e-02, 1.005013e-01
-6395, 4.873877e-02, -2.548020e-02, 2.688057e-01
-6396, 4.611594e-02, -2.955800e-02, 2.612857e-01
-6397, 5.452813e-02, 5.299972e-03, 1.255505e-01
-6398, 5.452813e-02, 5.299972e-03, 1.305337e-01
-6399, 5.396921e-02, 1.055670e-02, 1.278348e-01
-6400, 2.836914e-02, -4.623684e-02, 2.027797e-01
-6401, 1.152721e-02, -5.306617e-02, 3.881068e-01
-6402, 2.224499e-02, -5.025223e-02, 3.905331e-01
-6403, 4.211808e-02, 3.458457e-02, 1.149608e-01
-6404, 4.058711e-02, 3.678083e-02, 1.201233e-01
-6405, -5.169940e-02, -1.866739e-02, 1.968691e-01
-6406, -5.224063e-02, -1.680049e-02, 1.819819e-01
-6407, 5.446975e-02, -5.121647e-03, 2.304165e-01
-6408, 5.377903e-02, -1.152214e-02, 2.331026e-01
-6409, -3.927981e-02, 3.836204e-02, 4.895632e-01
-6410, -3.751363e-02, 4.021873e-02, 4.946200e-01
-6411, 4.335244e-02, 3.339665e-02, 2.846977e-01
-6412, 4.608230e-02, 3.001456e-02, 2.776944e-01
-6413, 4.818085e-02, 2.622042e-02, 2.833756e-01
-6414, -5.250689e-02, -1.178884e-02, 2.940899e-01
-6415, -4.810141e-02, -2.614590e-02, 3.000529e-01
-6416, -4.819144e-02, -2.601419e-02, 2.878610e-01
-6417, 5.057490e-02, 2.138812e-02, 4.519456e-01
-6418, 5.030967e-02, 2.209100e-02, 4.459151e-01
-6419, 5.236563e-02, 1.623966e-02, 4.482673e-01
-6420, -3.840588e-02, 3.935926e-02, 3.440431e-02
-6421, -4.055373e-02, 3.687938e-02, 2.765464e-02
-6422, -3.675591e-02, 4.088530e-02, 2.772438e-02
-6423, 5.500000e-02, -1.347111e-17, 4.560639e-02
-6424, 5.688167e-02, 6.065129e-03, 2.899747e-03
-6425, 5.666194e-02, 7.141323e-03, 7.579390e-03
-6426, 5.738313e-02, 6.028908e-04, 8.790630e-03
-6427, 5.427881e-02, 6.538432e-03, 1.057053e-02
-6428, 4.775921e-02, -2.726536e-02, 4.794699e-03
-6429, 4.900738e-02, -2.473483e-02, 9.843361e-03
-6430, 4.633621e-02, -2.958311e-02, 9.994452e-03
-6431, 4.651621e-02, 2.892147e-02, 3.618326e-01
-6432, 4.496852e-02, 3.162871e-02, 3.549692e-01
-6433, 4.247988e-02, -3.480429e-02, 2.244148e-02
-6434, -4.649411e-02, 2.851274e-02, 1.611596e-01
-6435, -4.745036e-02, 2.371386e-02, 1.746730e-01
-6436, -4.192172e-02, 3.549837e-02, 1.724333e-01
-6437, -3.548174e-02, 4.151951e-02, 4.687236e-01
-6438, -3.236220e-02, 4.439316e-02, 4.755734e-01
-6439, -4.794141e-02, 2.606960e-02, 1.230995e-01
-6440, -5.130397e-02, 1.981815e-02, 1.361767e-01
-6441, -4.825604e-02, 2.552154e-02, 1.473842e-01
-6442, -4.489347e-02, 3.177299e-02, 1.343070e-01
-6443, -4.408831e-02, 3.286643e-02, 1.587804e-01
-6444, -5.277017e-02, 1.307225e-02, 3.898605e-01
-6445, -4.945798e-02, 2.373181e-02, 3.898841e-01
-6446, -5.060402e-02, 2.028481e-02, 3.782607e-01
-6447, -4.841893e-02, 2.606550e-02, 2.121564e-01
-6448, -5.196363e-02, 1.561607e-02, 2.013970e-01
-6449, 5.500000e-02, -1.347111e-17, 2.163150e-01
-6450, 5.442386e-02, -5.336223e-03, 2.137335e-01
-6451, 5.500000e-02, -1.347111e-17, 2.218257e-01
-6452, 5.442386e-02, -5.336223e-03, 2.192442e-01
-6453, -3.789841e-02, 3.970068e-02, 1.487565e-02
-6454, -3.933291e-02, 3.797330e-02, 2.071169e-02
-6455, -4.198263e-02, 3.548448e-02, 1.274368e-02
-6456, -4.341714e-02, 3.375710e-02, 1.857972e-02
-6457, 1.976572e-02, -5.128363e-02, 2.281954e-01
-6458, 2.954464e-02, -4.516118e-02, 2.300865e-01
-6459, 3.829016e-02, -3.946705e-02, 2.243733e-01
-6460, 5.367194e-02, -1.200925e-02, 1.441458e-01
-6461, 5.431018e-02, -6.396358e-03, 1.470381e-01
-6462, 5.440318e-02, -5.954239e-03, 1.411924e-01
-6463, 5.376494e-02, -1.156714e-02, 1.383001e-01
-6464, -4.178773e-02, -3.554215e-02, 2.135705e-01
-6465, -4.878422e-02, -2.393428e-02, 2.079883e-01
-6466, -4.440402e-02, -3.098186e-02, 2.258924e-01
-6467, -5.140051e-02, -1.937399e-02, 2.203101e-01
-6468, 5.404631e-02, 1.013443e-02, 4.984014e-02
-6469, 2.457107e-02, 4.786839e-02, 2.877148e-01
-6470, 1.209185e-02, 5.364127e-02, 2.870205e-01
-6471, 1.686276e-02, 5.224342e-02, 2.970191e-01
-6472, -5.055087e-02, 2.159650e-02, 2.640177e-01
-6473, -5.330915e-02, 8.015156e-03, 2.626124e-01
-6474, -5.221740e-02, 1.324315e-02, 2.529624e-01
-6475, -5.497568e-02, -3.381958e-04, 2.515571e-01
-6476, 4.935549e-02, -2.425615e-02, 2.397431e-01
-6477, 4.360739e-02, -3.246388e-02, 2.374301e-01
-6478, 4.878714e-02, -2.539097e-02, 2.326755e-01
-6479, -5.397843e-02, 1.020184e-02, 2.139673e-01
-6480, -5.059515e-02, 1.641446e-02, 2.384264e-01
-6481, -4.791548e-02, 2.663336e-02, 2.516437e-01
-6482, -5.489708e-02, 3.024249e-03, 2.397451e-01
-6483, 5.246782e-02, 1.570712e-02, 3.635172e-01
-6484, -5.277800e-02, -7.710445e-03, 2.300125e-01
-6485, -5.418609e-02, 8.334817e-03, 2.278269e-01
-6486, 3.604693e-02, 4.153478e-02, 3.665645e-01
-6487, 3.479721e-03, 5.361792e-02, 3.047633e-01
-6488, -9.028252e-03, 5.424588e-02, 3.043872e-01
-6489, 1.265482e-02, 5.336999e-02, 3.159144e-01
-6490, 3.745466e-04, 5.417085e-02, 3.153061e-01
-6491, -5.341501e-02, 3.748971e-05, 1.674315e-01
-6492, -5.379431e-02, -1.103597e-02, 1.544569e-01
-6493, -5.320698e-02, -1.392401e-02, 1.713473e-01
-6494, 3.381287e-02, -4.310135e-02, 4.433818e-01
-6495, 2.598560e-02, -4.817601e-02, 4.394260e-01
-6496, 2.708481e-02, -4.769627e-02, 4.492753e-01
-6497, -2.408995e-02, -4.884730e-02, 3.831916e-01
-6498, -3.571794e-02, -4.152779e-02, 3.811139e-01
-6499, -3.532137e-02, -4.180005e-02, 3.704091e-01
-6500, -2.369337e-02, -4.911955e-02, 3.724869e-01
-6501, 1.731770e-02, 5.202296e-02, 4.208925e-02
-6502, 9.122562e-03, 5.401221e-02, 3.724406e-02
-6503, 9.172330e-03, 5.400874e-02, 4.606507e-02
-6504, 5.188372e-02, 5.574934e-03, 2.899747e-03
-6505, 5.377940e-02, 1.151048e-02, 4.679643e-03
-6506, 5.238313e-02, 6.028908e-04, 8.790630e-03
-6507, -5.401559e-02, -7.550808e-03, 4.111375e-01
-6508, -5.376573e-02, -3.009640e-03, 4.223976e-01
-6509, 4.947629e-02, -2.402106e-02, 1.690050e-01
-6510, 4.591190e-02, -2.938038e-02, 1.718841e-01
-6511, 4.352326e-02, -3.237780e-02, 1.669415e-01
-6512, -4.957788e-02, 2.374698e-02, 3.532743e-01
-6513, 3.131606e-02, -4.432512e-02, 2.994089e-01
-6514, -3.886678e-02, -3.888120e-02, 3.093608e-02
-6515, -4.077787e-02, -3.665685e-02, 4.075223e-02
-6516, -4.479875e-02, -3.179894e-02, 4.219062e-02
-6517, -4.833318e-02, -2.610722e-02, 6.338743e-02
-6518, -4.423636e-02, -3.223503e-02, 6.332832e-02
-6519, -4.628767e-02, -2.909376e-02, 5.111420e-02
-6520, -4.219084e-02, -3.522158e-02, 5.105510e-02
-6521, -4.567235e-02, -2.922729e-02, 1.880340e-01
-6522, 4.568623e-02, -3.019556e-02, 3.338800e-01
-6523, 4.558859e-02, -3.038018e-02, 3.280451e-01
-6524, 4.121919e-02, -3.627422e-02, 3.310108e-01
-6525, -5.399208e-02, 2.517190e-03, 3.260342e-01
-6526, -5.233028e-02, 1.616658e-02, 3.279571e-01
-6527, -5.424201e-02, 4.716395e-03, 3.370153e-01
-6528, 5.188230e-02, -1.745466e-02, 8.686769e-02
-6529, 5.392238e-02, -1.079226e-02, 8.911423e-02
-6530, 5.458508e-02, 4.972230e-03, 5.264382e-02
-6531, 5.400207e-02, 1.039083e-02, 5.540013e-02
-6532, 2.877240e-02, 4.665930e-02, 3.256530e-01
-6533, 2.531791e-02, 4.807335e-02, 3.177059e-01
-6534, 3.504751e-02, 4.219995e-02, 3.207083e-01
-6535, 4.621294e-02, 2.975017e-02, 2.429767e-01
-6536, 3.964007e-02, 3.749938e-02, 2.402763e-01
-6537, -5.497046e-02, 1.499030e-03, 3.023364e-01
-6538, -5.466193e-02, -2.604116e-03, 3.139183e-01
-6539, -5.219836e-02, -1.589199e-02, 3.056718e-01
-6540, -2.096775e-02, -5.062923e-02, 2.932198e-01
-6541, -3.116061e-02, -4.491943e-02, 3.005100e-01
-6542, -3.199272e-02, -4.418204e-02, 2.871530e-01
-6543, 4.889082e-02, -2.517981e-02, 1.559515e-01
-6544, 4.890781e-02, -2.514539e-02, 1.616150e-01
-6545, 5.174715e-02, -1.739324e-02, 1.642801e-01
-6546, 5.173016e-02, -1.742765e-02, 1.586167e-01
-6547, 2.512834e-02, 4.880546e-02, 4.492065e-02
-6548, 2.623439e-02, 4.829557e-02, 5.398937e-02
-6549, -3.060872e-02, 4.567744e-02, 3.241968e-01
-6550, -2.179550e-02, 4.913708e-02, 3.111859e-01
-6551, -1.101425e-02, 5.387821e-02, 3.205042e-01
-6552, -1.982747e-02, 5.041857e-02, 3.335151e-01
-6553, -3.903940e-02, 3.665787e-02, 3.302226e-01
-6554, -3.100023e-02, 4.539800e-02, 3.418009e-01
-6555, -3.275821e-02, 4.338379e-02, 1.704311e-01
-6556, -3.406235e-02, 4.261453e-02, 1.819260e-01
-6557, 5.156264e-02, -1.779293e-02, 2.360254e-01
-6558, 5.277392e-02, 1.499950e-02, 4.048271e-02
-6559, 2.944255e-02, 4.607776e-02, 2.142981e-01
-6560, 2.914824e-02, 4.630650e-02, 2.243746e-01
-6561, -2.521446e-02, -4.825220e-02, 4.480707e-01
-6562, -2.880537e-02, 4.552492e-02, 4.021613e-01
-6563, -3.144767e-02, 4.432057e-02, 3.887451e-01
-6564, -3.884730e-02, 3.893423e-02, 4.001550e-01
-6565, 5.251005e-02, 1.526443e-02, 1.860390e-01
-6566, 5.102903e-02, 2.051900e-02, 1.856786e-01
-6567, 5.259687e-02, 1.504509e-02, 1.805063e-01
-6568, 5.111585e-02, 2.029966e-02, 1.801458e-01
-6569, 1.785826e-02, -5.174903e-02, 4.157597e-01
-6570, 8.700475e-03, -5.406817e-02, 4.107851e-01
-6571, 6.399511e-03, -5.409557e-02, 4.206818e-01
-6572, 3.927329e-02, -3.730513e-02, 3.426080e-02
-6573, 4.430386e-02, -3.253174e-02, 3.857584e-02
-6574, 4.500312e-02, -3.161066e-02, 2.995076e-02
-6575, 5.430740e-02, 8.663970e-03, 2.746837e-02
-6576, 5.344795e-02, 1.264184e-02, 2.368246e-02
-6577, 3.672922e-02, 4.082125e-02, 2.324318e-02
-6578, 3.923876e-02, 3.853985e-02, 1.638336e-02
-6579, 4.136603e-02, 3.612807e-02, 2.224737e-02
-6580, 5.399423e-02, -1.022440e-02, 1.074548e-02
-6581, -8.813157e-03, 5.418636e-02, 3.432905e-01
-6582, -1.998592e-02, 4.916578e-02, 3.515764e-01
-6583, -6.790068e-03, 5.455958e-02, 3.574149e-01
-6584, 5.500000e-02, -1.347111e-17, 1.722367e-01
-6585, 5.500000e-02, -1.347111e-17, 1.670132e-01
-6586, 5.456115e-02, 5.112548e-03, 1.694890e-01
-6587, 3.728967e-02, -4.041989e-02, 1.180174e-01
-6588, 4.340483e-02, -3.279652e-02, 1.189542e-01
-6589, 5.422029e-02, 9.226809e-03, 1.776470e-01
-6590, 5.421184e-02, 9.275401e-03, 1.832164e-01
-6591, -5.418476e-02, 9.358072e-03, 4.949905e-01
-6592, -5.359197e-02, 1.173912e-02, 4.901165e-01
-6593, -5.309705e-02, 1.425910e-02, 4.951260e-01
-6594, -2.766350e-02, -4.725432e-02, 1.420993e-01
-6595, -1.531817e-02, -5.235907e-02, 1.417311e-01
-6596, -2.200989e-02, -5.036785e-02, 1.494247e-01
-6597, 4.710682e-02, 2.813145e-02, 4.435056e-01
-6598, 5.024089e-02, 2.226499e-02, 4.399240e-01
-6599, 3.904392e-02, -3.867463e-02, 3.918052e-01
-6600, 4.392094e-02, -3.245505e-02, 3.848168e-01
-6601, 3.902672e-02, -3.869330e-02, 3.825162e-01
-6602, 5.729138e-02, 1.643076e-03, 4.971926e-01
-6603, 5.678685e-02, 7.121879e-03, 4.971926e-01
-6604, 5.229138e-02, 1.643076e-03, 4.971926e-01
-6605, 5.181793e-02, -1.816416e-02, 4.956744e-01
-6606, -3.124328e-02, -4.405730e-02, 1.544199e-01
-6607, 2.304483e-02, -4.993889e-02, 3.058593e-01
-6608, 5.048021e-02, 2.173631e-02, 4.249988e-01
-6609, 5.045368e-02, 2.179135e-02, 4.153130e-01
-6610, 5.234872e-02, 1.634053e-02, 4.196687e-01
-6611, -4.594671e-02, -2.962284e-02, 1.519041e-01
-6612, -5.214333e-02, -1.545162e-02, 1.441813e-01
-6613, -4.576494e-02, 3.040052e-02, 3.077722e-01
-6614, -4.653303e-02, 2.905460e-02, 2.927013e-01
-6615, -4.869192e-02, 2.526712e-02, 3.225166e-01
-6616, -4.946002e-02, 2.392120e-02, 3.074457e-01
-6617, 3.863989e-02, -3.907129e-02, 1.370618e-02
-6618, 3.532625e-02, -4.211716e-02, 1.478946e-02
-6619, 4.750418e-02, 2.692567e-02, 1.827797e-01
-6620, 4.818593e-02, 2.594016e-02, 1.772634e-01
-6621, 5.406553e-02, 1.006591e-02, 1.725278e-01
-6622, 5.456115e-02, 5.112548e-03, 1.747125e-01
-6623, 5.419307e-02, 9.381782e-03, 1.888166e-01
-6624, 5.465913e-02, 4.114260e-03, 1.857621e-01
-6625, 5.453393e-02, 5.267521e-03, 1.912496e-01
-6626, 5.500000e-02, -1.347111e-17, 1.881951e-01
-6627, 2.812313e-02, 4.671390e-02, 8.465206e-02
-6628, 2.712557e-02, 4.710827e-02, 9.445749e-02
-6629, 1.685903e-02, 5.230741e-02, 9.799333e-02
-6630, 1.785658e-02, 5.191304e-02, 8.818791e-02
-6631, 2.929847e-02, 4.626935e-02, 3.347759e-01
-6632, 3.703212e-02, 4.026258e-02, 3.369985e-01
-6633, 3.650605e-02, 4.065254e-02, 3.278756e-01
-6634, -3.232194e-02, 4.448948e-02, 3.113446e-01
-6635, 5.228480e-02, 1.687177e-02, 4.593200e-03
-6636, 5.172015e-02, 1.828429e-02, 9.631378e-03
-6637, 2.210816e-02, -4.989557e-02, 3.650382e-01
-6638, 3.188331e-02, -4.447838e-02, 3.617343e-01
-6639, 2.356846e-02, -4.942569e-02, 3.568033e-01
-6640, 5.236015e-02, 1.643958e-02, 3.920782e-01
-6641, 5.388795e-02, 1.088108e-02, 3.949253e-01
-6642, 5.386342e-02, 1.098396e-02, 3.889477e-01
-6643, 5.233562e-02, 1.654245e-02, 3.861006e-01
-6644, 4.627714e-02, -2.923568e-02, 2.553290e-01
-6645, -4.255132e-02, -3.483383e-02, 4.845371e-01
-6646, -4.418704e-02, -3.271710e-02, 4.789915e-01
-6647, 5.152466e-02, -1.796445e-02, 2.300161e-01
-6648, 5.374105e-02, -1.169365e-02, 2.270933e-01
-6649, 5.500000e-02, -1.347111e-17, 2.994414e-01
-6650, 5.455282e-02, 5.160487e-03, 3.022636e-01
-6651, 5.454670e-02, 5.195408e-03, 3.134892e-01
-6652, 5.388393e-02, 1.091376e-02, 3.163961e-01
-6653, 5.389005e-02, 1.087884e-02, 3.107710e-01
-6654, 5.455282e-02, 5.160487e-03, 3.078640e-01
-6655, 5.449478e-02, -5.482521e-03, 9.745105e-02
-6656, 5.377315e-02, -1.153139e-02, 1.328792e-01
-6657, 5.440318e-02, -5.954239e-03, 1.356817e-01
-6658, 5.461506e-02, -4.790432e-03, 1.304108e-01
-6659, 5.398503e-02, -1.036758e-02, 1.276084e-01
-6660, 3.416307e-02, -4.271379e-02, 7.479739e-02
-6661, 2.868188e-02, -4.689526e-02, 6.803902e-02
-6662, 4.773741e-02, 2.723690e-02, 1.076810e-01
-6663, 5.030749e-02, 2.198782e-02, 1.105163e-01
-6664, -2.737060e-02, 4.762704e-02, 3.747737e-01
-6665, -5.168735e-02, -1.873233e-02, 4.192565e-02
-6666, -4.969420e-02, 2.347614e-02, 3.368445e-01
-6667, -5.221397e-02, 1.643743e-02, 3.443868e-01
-6668, 5.378571e-02, -1.147352e-02, 4.326029e-01
-6669, 5.440818e-02, -5.929500e-03, 4.349966e-01
-6670, 5.398629e-02, -1.037322e-02, 4.273634e-01
-6671, 5.444613e-02, -5.233229e-03, 3.465549e-01
-6672, 5.444613e-02, -5.233229e-03, 3.528539e-01
-6673, 5.385865e-02, 1.101086e-02, 3.049136e-01
-6674, 2.576402e-02, 4.814540e-02, 3.566968e-01
-6675, 5.051829e-02, 2.162441e-02, 4.094891e-01
-6676, 5.241333e-02, 1.617359e-02, 4.138448e-01
-6677, 3.827975e-02, 3.909364e-02, 1.841344e-01
-6678, 3.361606e-02, 4.350717e-02, 1.899840e-01
-6679, 3.158183e-02, 4.484110e-02, 1.823023e-01
-6680, 5.500000e-02, -1.347111e-17, 3.106422e-01
-6681, 5.392263e-02, 1.073752e-02, 4.330172e-01
-6682, 5.455343e-02, 5.157013e-03, 4.300879e-01
-6683, 5.390042e-02, 1.086320e-02, 4.386545e-01
-6684, 5.453122e-02, 5.282689e-03, 4.357252e-01
-6685, 1.611540e-02, 5.248186e-02, 1.531685e-01
-6686, 1.622622e-02, 5.245417e-02, 1.414444e-01
-6687, 5.012733e-02, -2.240267e-02, 4.516889e-01
-6688, 4.574535e-02, -3.013638e-02, 4.495228e-01
-6689, 5.055475e-02, -2.155161e-02, 4.576729e-01
-6690, 5.414109e-02, 9.678836e-03, 4.276267e-01
-6691, 5.223383e-02, 1.669637e-02, 4.361733e-01
-6692, 5.245229e-02, 1.563769e-02, 4.307828e-01
-6693, 3.990034e-02, 3.686656e-02, 1.913709e-01
-6694, 3.559741e-02, 4.190474e-02, 1.966702e-01
-6695, 4.536291e-02, 3.107124e-02, 1.942727e-01
-6696, 4.105998e-02, 3.610942e-02, 1.995720e-01
-6697, 7.128110e-03, 5.411859e-02, 1.603747e-01
-6698, 1.739128e-02, 5.195519e-02, 1.618351e-01
-6699, -1.816841e-02, 5.106853e-02, 3.650300e-01
-6700, -5.779031e-03, 5.463489e-02, 3.691057e-01
-6701, 3.492742e-03, -5.488451e-02, 2.567118e-01
-6702, 2.821388e-02, 4.680599e-02, 1.554437e-01
-6703, 3.672062e-02, 4.070408e-02, 1.684656e-01
-6704, 3.107200e-02, 4.524582e-02, 1.734500e-01
-6705, 2.856974e-02, 4.653397e-02, 1.658003e-01
-6706, 4.620129e-02, -2.938807e-02, 2.873348e-01
-6707, 4.321159e-02, -3.401489e-02, 2.924343e-01
-6708, 3.636476e-02, 4.097609e-02, 1.581090e-01
-6709, 5.158210e-02, -9.478055e-03, 3.191758e-01
-6710, 5.154883e-02, -9.626273e-03, 3.246574e-01
-6711, 5.650351e-02, -1.037711e-02, 3.192960e-01
-6712, 5.374104e-02, -1.169924e-02, 3.163394e-01
-6713, 5.370778e-02, -1.184746e-02, 3.218211e-01
-6714, -1.020369e-02, -5.351023e-02, 2.882965e-01
-6715, 5.013270e-02, 2.255605e-02, 3.584248e-01
-6716, 4.858501e-02, 2.526329e-02, 3.515614e-01
-6717, -5.450012e-02, 3.229590e-03, 4.516101e-01
-6718, -5.482115e-02, -4.177774e-03, 4.514485e-01
-6719, 5.386455e-02, -1.100906e-02, 1.944215e-01
-6720, 5.390128e-02, -1.085169e-02, 1.887958e-01
-6721, 5.251217e-02, -1.598032e-02, 1.842971e-01
-6722, 4.084418e-02, -3.679595e-02, 4.901821e-01
-6723, -8.510306e-03, 5.431013e-02, 2.428060e-01
-6724, -2.559134e-03, 5.432032e-02, 2.341494e-01
-6725, 4.211068e-03, 5.393311e-02, 2.474440e-01
-6726, 4.194495e-02, 3.522139e-02, 3.167411e-01
-6727, 4.258850e-02, 3.402502e-02, 3.899444e-01
-6728, 4.754630e-02, 2.760106e-02, 3.933457e-01
-6729, 4.159086e-02, 3.582131e-02, 1.290891e-01
-6730, 2.335172e-02, -4.968429e-02, 4.006982e-01
-6731, 5.679694e-02, 3.292165e-03, 2.938992e-01
-6732, 5.223910e-02, -1.839515e-03, 2.966277e-01
-6733, 5.455784e-02, 5.131680e-03, 2.967129e-01
-6734, -5.468165e-02, 3.308834e-03, 4.104528e-01
-6735, -5.367545e-02, 7.382949e-03, 4.000843e-01
-6736, -5.466513e-02, -4.665483e-03, 4.002150e-01
-6737, -3.860559e-02, 3.908172e-02, 9.645964e-03
-6738, 4.586808e-02, 2.991917e-02, 1.414886e-01
-6739, 4.999201e-02, 2.280120e-02, 1.442745e-01
-6740, -5.359731e-02, 1.234190e-02, 4.776210e-01
-6741, -5.316056e-02, 1.399047e-02, 4.842313e-01
-6742, -5.411951e-02, 9.080271e-03, 4.836307e-01
-6743, 1.403075e-03, 5.497361e-02, 4.061637e-01
-6744, 1.183873e-02, 5.299423e-02, 4.023135e-01
-6745, 9.796110e-03, 5.342283e-02, 4.112686e-01
-6746, -8.501190e-04, 5.497289e-02, 4.165092e-01
-6747, 3.524777e-02, 4.218424e-02, 2.053892e-01
-6748, 4.179655e-02, 3.503512e-02, 2.049625e-01
-6749, 1.621907e-02, -5.237191e-02, 4.362778e-01
-6750, 5.918320e-03, -5.421125e-02, 4.315936e-01
-6751, 5.371308e-02, -1.182763e-02, 1.497628e-01
-6752, 4.464867e-02, 3.205029e-02, 4.772375e-01
-6753, 4.696314e-02, 2.857287e-02, 4.716178e-01
-6754, 4.765160e-02, 2.729244e-02, 4.776395e-01
-6755, 5.127091e-02, -1.887554e-02, 1.400727e-01
-6756, 4.950784e-02, 2.354379e-02, 4.728162e-01
-6757, 5.019630e-02, 2.226336e-02, 4.788379e-01
-6758, 4.524296e-02, 3.125364e-02, 4.948468e-01
-6759, -2.267656e-02, -5.009546e-02, 4.945706e-01
-6760, 5.404721e-02, -1.004273e-02, 2.774966e-01
-6761, 5.408043e-02, -9.717826e-03, 1.835574e-01
-6762, -5.068156e-02, 2.128856e-02, 5.233970e-02
-6763, 5.738313e-02, 6.028908e-04, 2.899747e-03
-6764, 5.443907e-02, -5.774171e-03, 2.473244e-01
-6765, 4.183772e-02, -3.569535e-02, 1.394778e-01
-6766, 4.570978e-02, -2.974100e-02, 1.456055e-01
-6767, 3.952921e-02, -3.816536e-02, 1.481404e-01
-6768, 5.500000e-02, -1.347111e-17, 2.329817e-01
-6769, 5.500000e-02, -1.347111e-17, 2.388053e-01
-6770, 1.875631e-02, 5.139044e-02, 3.351825e-01
-6771, 9.278297e-03, 5.415239e-02, 1.006422e-02
-6772, 5.450268e-02, 5.439829e-03, 1.359404e-01
-6773, 5.450268e-02, 5.439829e-03, 1.414511e-01
-6774, 1.606100e-03, 5.391750e-02, 2.950695e-01
-6775, 5.500000e-02, -1.347111e-17, 1.331886e-01
-6776, 4.808639e-03, -5.467277e-02, 4.893459e-01
-6777, 8.110443e-03, -5.439869e-02, 4.839596e-01
-6778, -5.241440e-02, -1.659472e-02, 4.946828e-01
-6779, -5.377695e-02, -1.147336e-02, 4.946334e-01
-6780, 5.391983e-02, 1.077870e-02, 1.614807e-01
-6781, 5.453041e-02, 5.287231e-03, 1.581865e-01
-6782, 5.388409e-02, 1.093508e-02, 1.557367e-01
-6783, 5.500000e-02, -1.347111e-17, 3.940816e-01
-6784, -5.347717e-02, -1.115042e-02, 8.795714e-02
-6785, -5.459985e-02, -6.615385e-03, 4.944121e-01
-6786, -1.571329e-02, 5.230809e-02, 2.353335e-01
-6787, -2.722375e-02, 4.753169e-02, 2.277153e-01
-6788, -9.292379e-03, 5.420246e-02, 2.240852e-01
-6789, -2.080284e-02, 4.942607e-02, 2.164670e-01
-6790, -2.710526e-02, 4.772064e-02, 4.886988e-01
-6791, -3.000085e-02, 4.609717e-02, 4.817444e-01
-6792, -2.790343e-02, 4.734268e-02, 4.757083e-01
-6793, 5.040580e-02, 2.200566e-02, 4.950700e-01
-6794, 5.217898e-02, 1.725130e-02, 4.949755e-01
-6795, 5.500000e-02, -1.347111e-17, 3.560693e-01
-6796, 5.462741e-02, -4.713431e-03, 3.583835e-01
-6797, 5.407354e-02, -9.946660e-03, 3.551681e-01
-6798, -1.159522e-02, 5.361243e-02, 6.511280e-02
-6799, -9.652342e-03, 5.383375e-02, 5.075472e-02
-6800, 5.443575e-02, -5.791092e-03, 3.741640e-01
-6801, 5.500000e-02, -1.347111e-17, 3.770572e-01
-6802, 3.354753e-02, -4.354566e-02, 3.602425e-02
-6803, 3.712593e-02, 4.056340e-02, 4.084647e-01
-6804, 5.362051e-02, -1.221304e-02, 3.773241e-01
-6805, 5.371680e-02, -1.174346e-02, 3.714910e-01
-6806, -3.367181e-02, 4.348769e-02, 4.943803e-01
-6807, 5.241173e-02, -1.617320e-02, 2.777459e-01
-6808, 2.812883e-02, 4.629145e-02, 1.065855e-01
-6809, 3.825382e-02, 3.931206e-02, 1.018188e-01
-6810, 3.620491e-02, 4.139469e-02, 1.114942e-01
-6811, -4.320925e-02, -3.402435e-02, 1.101480e-01
-6812, -3.820199e-02, -3.873464e-02, 9.802688e-02
-6813, -1.972285e-02, -5.121401e-02, 1.818654e-01
-6814, -2.870345e-02, -4.628836e-02, 1.808792e-01
-6815, -2.315954e-02, -4.988451e-02, 1.899906e-01
-6816, 3.832928e-02, -3.944194e-02, 2.933725e-01
-6817, 4.141821e-02, -3.598908e-02, 2.858568e-01
-6818, 5.147694e-02, -1.936724e-02, 4.806081e-01
-6819, 5.266967e-02, -1.543333e-02, 4.820586e-01
-6820, 5.444299e-02, -7.482312e-03, 4.770280e-01
-6821, 5.382986e-02, -1.121791e-02, 4.777929e-01
-6822, 4.029107e-02, -3.713639e-02, 3.604317e-01
-6823, 5.456087e-02, -6.782254e-03, 4.820505e-01
-6824, 5.485148e-02, -2.981480e-03, 4.795436e-01
-6825, 3.645153e-02, 4.116569e-02, 3.802456e-01
-6826, 3.706093e-02, 4.063470e-02, 3.902139e-01
-6827, 2.885145e-02, 4.586505e-02, 3.852962e-01
-6828, -4.007125e-02, -3.699103e-02, 3.059122e-01
-6829, -3.036758e-02, -4.532076e-02, 3.141052e-01
-6830, 5.374673e-02, -1.162001e-02, 3.659485e-01
-6831, 5.223152e-02, -1.680358e-02, 3.610830e-01
-6832, 5.393839e-02, -1.054235e-02, 3.606620e-01
-6833, -4.045834e-02, 3.725620e-02, 5.347010e-03
-6834, 5.403834e-02, -1.022477e-02, 4.978841e-02
-6835, 5.406055e-02, -1.009962e-02, 4.422849e-02
-6836, 5.219599e-02, -1.647664e-02, 4.691946e-02
-6837, -5.287595e-02, 1.507292e-02, 2.485353e-02
-6838, -5.391460e-02, 1.047540e-02, 1.771279e-02
-6839, -5.421166e-02, 7.013998e-03, 2.480956e-02
-6840, -2.845373e-03, -5.456892e-02, 2.497580e-01
-6841, -2.107980e-02, -5.073643e-02, 4.563000e-01
-6842, -1.738786e-02, -5.214835e-02, 4.462579e-01
-6843, 3.548756e-02, -4.126774e-02, 6.853364e-02
-6844, -3.492480e-02, 4.075186e-02, 1.567782e-01
-6845, -3.997400e-02, 3.721844e-02, 1.459949e-01
-6846, 2.093765e-02, -5.085613e-02, 1.981433e-01
-6847, 9.659959e-03, -5.321206e-02, 1.908348e-01
-6848, 8.847524e-03, -5.352051e-02, 1.995268e-01
-6849, 1.665964e-03, -5.490510e-02, 1.022107e-01
-6850, 1.318086e-02, -5.241389e-02, 1.078824e-01
-6851, 5.395677e-02, 1.058628e-02, 4.222719e-01
-6852, 1.692170e-04, -5.395285e-02, 7.972676e-02
-6853, -1.176025e-02, -5.372755e-02, 8.219470e-02
-6854, -7.678987e-03, -5.434533e-02, 6.962336e-02
-6855, 1.696114e-03, -5.455643e-02, 7.031304e-02
-6856, 1.136260e-02, -5.377199e-02, 7.005662e-02
-6857, 9.544318e-03, -5.416395e-02, 8.041644e-02
-6858, -4.373018e-02, 3.304418e-02, 5.347010e-03
-6859, 5.500000e-02, -1.347111e-17, 4.772079e-01
-6860, 5.459151e-02, -4.500832e-03, 4.746922e-01
-6861, 5.232025e-02, -1.640226e-02, 8.090889e-02
-6862, 3.584011e-04, -5.499756e-02, 1.946218e-01
-6863, -1.550483e-03, -5.492280e-02, 2.036769e-01
-6864, 3.326641e-02, 4.378667e-02, 1.987030e-01
-6865, 2.580953e-02, 4.749708e-02, 2.057446e-01
-6866, 3.484453e-02, 4.253382e-02, 2.927137e-01
-6867, 2.713623e-02, 4.690885e-02, 3.020180e-01
-6868, 5.259803e-02, 1.526408e-02, 4.084418e-01
-6869, 5.394774e-02, -1.051785e-02, 4.828154e-01
-6870, 4.868916e-02, 2.556583e-02, 4.843034e-01
-6871, 7.787662e-03, -5.409629e-02, 3.434302e-02
-6872, 1.038381e-02, -5.390886e-02, 2.589730e-02
-6873, 5.397812e-02, 1.049065e-02, 2.107559e-01
-6874, 5.455235e-02, 5.163180e-03, 2.081660e-01
-6875, 5.454405e-02, 5.210501e-03, 2.136610e-01
-6876, 5.396981e-02, 1.053797e-02, 2.162509e-01
-6877, 5.363379e-02, -1.216766e-02, 2.102579e-01
-6878, 5.392776e-02, -1.061108e-02, 2.052479e-01
-6879, 5.184092e-02, -1.774740e-02, 2.034617e-01
-6880, 4.725977e-02, 2.793029e-02, 3.247987e-01
-6881, 5.019529e-02, 2.235540e-02, 3.281417e-01
-6882, 4.589202e-02, 3.031351e-02, 4.828815e-01
-6883, 4.383549e-02, 3.304601e-02, 3.294536e-01
-6884, 1.950575e-02, -5.089364e-02, 6.548620e-02
-6885, 1.792093e-02, -5.152347e-02, 7.581168e-02
-6886, 4.296942e-02, 3.427233e-02, 3.348402e-01
-6887, -8.198840e-03, -5.432002e-02, 4.951945e-03
-6888, 5.233367e-02, -1.634130e-02, 7.521349e-02
-6889, -4.330815e-02, 3.370479e-02, 4.791778e-01
-6890, -4.612590e-02, 2.995009e-02, 4.804981e-01
-6891, -4.742491e-02, 2.777134e-02, 4.738501e-01
-6892, 4.913055e-02, -2.469044e-02, 3.226455e-01
-6893, 4.922819e-02, -2.450582e-02, 3.284803e-01
-6894, -4.148522e-02, 3.610887e-02, 4.837017e-01
-6895, -2.358005e-02, -4.938751e-02, 1.661420e-02
-6896, -2.071317e-02, -5.091473e-02, 1.121018e-02
-6897, 5.145648e-02, -1.845868e-02, 3.256402e-01
-6898, 5.148974e-02, -1.831046e-02, 3.201586e-01
-6899, -3.150060e-02, 4.462908e-02, 4.522398e-01
-6900, -2.855312e-02, 4.691133e-02, 4.603396e-01
-6901, -4.826162e-02, 2.580363e-02, 1.005962e-01
-6902, -3.961022e-02, 3.815221e-02, 4.614328e-01
-6903, 1.393515e-02, 5.320385e-02, 3.436749e-02
-6904, 1.745245e-02, 5.206981e-02, 3.695916e-01
-6905, -3.348027e-02, 4.302455e-02, 4.104427e-01
-6906, -2.343835e-02, 4.961525e-02, 4.124490e-01
-6907, -4.924114e-02, -2.440808e-02, 1.747662e-02
-6908, -4.661920e-02, -2.895707e-02, 1.732587e-02
-6909, -4.795795e-02, -2.690982e-02, 1.152996e-02
-6910, -4.862352e-02, -2.560339e-02, 5.183813e-03
-6911, -3.149815e-02, -4.443647e-02, 2.737379e-01
-6912, -4.173238e-02, -3.496639e-02, 2.673751e-01
-6913, -4.099339e-02, -3.612192e-02, 2.803632e-01
-6914, 4.971424e-02, -2.348692e-02, 4.143404e-01
-6915, 4.502306e-02, -3.088332e-02, 4.192788e-01
-6916, 4.981034e-02, -2.326866e-02, 4.238504e-01
-6917, -4.760509e-02, -2.718234e-02, 4.730883e-01
-6918, 4.931763e-02, -2.434687e-02, 1.485576e-01
-6919, 4.528298e-02, -3.057394e-02, 1.529994e-01
-6920, -4.652837e-02, 2.850178e-02, 3.650659e-01
-6921, -4.523110e-02, 3.106215e-02, 3.777829e-01
-6922, 3.498643e-02, -4.190158e-02, 4.503571e-01
-6923, 4.089724e-02, -3.656431e-02, 4.468913e-01
-6924, -1.401352e-02, 5.311049e-02, 1.622078e-01
-6925, -1.718603e-02, 5.183444e-02, 1.521181e-01
-6926, -6.382284e-03, 5.433250e-02, 1.528153e-01
-6927, 5.223910e-02, -1.839515e-03, 2.911170e-01
-6928, 5.455784e-02, 5.131680e-03, 2.912022e-01
-6929, 4.105472e-02, 3.592906e-02, 2.981671e-01
-6930, -1.208979e-02, 5.345803e-02, 1.764991e-01
-6931, -4.458552e-03, 5.468004e-02, 1.671066e-01
-6932, -5.154305e-02, 1.791390e-02, 1.867512e-01
-6933, -4.343773e-02, 3.334513e-02, 1.857358e-01
-6934, 5.440981e-02, -5.400095e-03, 3.134307e-01
-6935, 5.374246e-02, -1.169264e-02, 3.104633e-01
-6936, -3.277514e-02, -4.395560e-02, 1.678228e-02
-6937, -5.484587e-02, -3.741372e-03, 1.172318e-02
-6938, -5.497105e-02, -1.706461e-03, 6.284142e-03
-6939, -5.467012e-02, -6.004088e-03, 5.439035e-03
-6940, -3.663838e-02, -4.100759e-02, 1.582752e-02
-6941, -5.353915e-02, -1.247934e-02, 2.289731e-02
-6942, -3.124536e-02, 4.524074e-02, 3.587915e-01
-6943, -7.550637e-03, -5.391620e-02, 1.754681e-01
-6944, -6.895453e-03, -5.391502e-02, 1.895813e-01
-6945, 4.533688e-02, -3.113589e-02, 5.199753e-03
-6946, 2.123299e-02, 5.030192e-02, 1.825342e-01
-6947, 5.009470e-02, -2.246324e-02, 2.807373e-01
-6948, 5.037078e-02, -2.192687e-02, 2.863525e-01
-6949, 5.240946e-02, -1.618341e-02, 2.832668e-01
-6950, 1.989355e-02, 5.066704e-02, 1.694849e-01
-6951, -5.494651e-02, -6.182840e-04, 3.146226e-02
-6952, -5.451220e-02, -4.026587e-03, 2.492776e-02
-6953, -5.497623e-02, 1.613849e-03, 2.496753e-02
-6954, 1.688148e-02, 5.231571e-02, 1.365602e-02
-6955, 1.904282e-02, 5.141732e-02, 8.708736e-03
-6956, 6.284866e-03, 5.463408e-02, 5.429984e-03
-6957, -5.073828e-02, -2.120503e-02, 2.340308e-01
-6958, -5.285735e-02, -1.047033e-02, 2.437635e-01
-6959, -9.379159e-03, 5.416794e-02, 5.397653e-03
-6960, -6.522651e-03, 5.444159e-02, 1.131098e-02
-6961, -5.078351e-02, -2.093302e-02, 4.544932e-03
-6962, 5.678663e-02, -6.671031e-03, 4.110021e-01
-6963, 5.718812e-02, -1.779419e-03, 4.134157e-01
-6964, 5.661420e-02, -7.619422e-03, 4.163869e-01
-6965, 4.343399e-02, 3.349220e-02, 2.276328e-01
-6966, 3.674921e-02, 4.063057e-02, 2.272383e-01
-6967, 3.389452e-02, 4.331085e-02, 2.343732e-01
-6968, -8.641260e-03, 5.431631e-02, 2.103083e-01
-6969, -5.193142e-02, -1.571364e-02, 3.666570e-01
-6970, -4.861344e-02, -2.560618e-02, 3.628591e-01
-6971, 3.841815e-02, -3.935590e-02, 1.753451e-01
-6972, -3.875846e-02, -3.883403e-02, 1.886949e-01
-6973, -4.275716e-02, -3.449418e-02, 1.991531e-01
-6974, -3.321456e-02, -4.243018e-02, 1.978064e-01
-6975, 1.222839e-02, -5.261032e-02, 3.011125e-01
-6976, 2.121235e-02, -5.070460e-02, 2.967400e-01
-6977, 5.332762e-02, -1.340340e-02, 4.871639e-01
-6978, 5.222342e-02, -1.714331e-02, 4.860284e-01
-6979, 5.500000e-02, -1.347111e-17, 5.058963e-02
-6980, 5.244211e-02, 1.588419e-02, 1.753870e-01
-6981, 5.241973e-02, 1.594122e-02, 1.697072e-01
-6982, 5.374549e-02, -1.167988e-02, 2.155942e-01
-6983, 5.369515e-02, -1.190823e-02, 2.214990e-01
-6984, 5.395057e-02, 1.060402e-02, 1.669372e-01
-6985, 5.408890e-02, -9.913694e-03, 4.053367e-01
-6986, 5.459852e-02, -4.891611e-03, 4.027039e-01
-6987, 4.266308e-02, 3.467689e-02, 4.837550e-01
-6988, 4.390643e-02, 3.294011e-02, 4.893990e-01
-6989, 4.118335e-02, -3.620914e-02, 1.844184e-01
-6990, 4.612353e-02, -2.955966e-02, 1.819085e-01
-6991, 4.272408e-02, -3.459037e-02, 1.788940e-01
-6992, -5.330255e-02, 1.016183e-02, 2.753447e-01
-6993, -5.471081e-02, -2.475464e-03, 2.756715e-01
-6994, -5.471740e-02, -4.622141e-03, 2.629392e-01
-6995, 5.453041e-02, 5.287231e-03, 1.640325e-01
-6996, -5.425686e-02, -8.839176e-03, 4.890455e-01
-6997, 4.571910e-02, -3.031840e-02, 1.876114e-01
-6998, -5.482725e-02, 4.294792e-03, 4.844916e-01
-6999, -5.479156e-02, -3.861124e-03, 4.893468e-01
-7000, -5.488454e-02, 1.608986e-03, 4.894601e-01
-7001, -4.997975e-02, 2.244721e-02, 4.116990e-01
-7002, -5.098595e-02, 1.837310e-02, 4.220675e-01
-7003, -5.443179e-02, 7.850003e-03, 4.217129e-01
-7004, -5.342559e-02, 1.192412e-02, 4.113444e-01
-7005, 2.042424e-02, -5.103459e-02, 4.792462e-01
-7006, 1.535901e-02, -5.272343e-02, 4.790832e-01
-7007, 5.236533e-02, 1.642599e-02, 3.977555e-01
-7008, 5.384738e-02, -1.118044e-02, 1.729302e-01
-7009, 5.444012e-02, -5.768812e-03, 1.702214e-01
-7010, 5.444012e-02, -5.768812e-03, 1.754448e-01
-7011, 5.416901e-02, 9.516391e-03, 4.056241e-01
-7012, 5.262271e-02, 1.519953e-02, 4.029669e-01
-7013, 4.907761e-02, -2.481944e-02, 1.425834e-01
-7014, 1.752800e-02, -5.212724e-02, 4.946064e-01
-7015, 5.391163e-02, 1.074285e-02, 4.004127e-01
-7016, -2.045307e-02, -4.979730e-02, 3.536143e-01
-7017, -2.001183e-02, -4.975605e-02, 3.459525e-01
-7018, -3.106895e-02, -4.536344e-02, 3.501495e-01
-7019, -2.460965e-02, -4.831203e-02, 4.430378e-01
-7020, -1.869415e-02, -5.163418e-02, 4.357422e-01
-7021, 5.375813e-02, -1.162168e-02, 1.614597e-01
-7022, 3.303359e-02, -4.368894e-02, 4.794837e-01
-7023, 2.916617e-02, -4.662622e-02, 4.799669e-01
-7024, 5.169278e-02, -6.731331e-03, 4.165834e-01
-7025, 5.218812e-02, -1.779419e-03, 4.194904e-01
-7026, 5.218812e-02, -1.779419e-03, 4.134157e-01
-7027, -4.678216e-02, 2.890068e-02, 4.848064e-03
-7028, -4.815194e-02, 2.654086e-02, 1.186023e-02
-7029, -4.503461e-02, 3.134098e-02, 1.224474e-02
-7030, 1.009373e-02, -5.398885e-02, 4.697861e-01
-7031, 5.534749e-03, -5.470462e-02, 4.631928e-01
-7032, 1.063328e-02, -5.391378e-02, 4.775516e-01
-7033, 6.074299e-03, -5.462956e-02, 4.709583e-01
-7034, 5.392109e-02, -1.080422e-02, 7.213475e-02
-7035, 5.449879e-02, -5.460913e-03, 7.507099e-02
-7036, 5.449879e-02, -5.460913e-03, 6.953786e-02
-7037, 5.458097e-02, 4.996631e-03, 4.077852e-01
-7038, 5.413686e-02, 9.703140e-03, 4.113488e-01
-7039, 5.454882e-02, 5.183379e-03, 4.135098e-01
-7040, 5.431018e-02, -6.396358e-03, 1.525936e-01
-7041, 5.432168e-02, -6.343427e-03, 1.585796e-01
-7042, 5.374663e-02, -1.167461e-02, 1.554737e-01
-7043, 5.268928e-02, -1.464221e-02, 4.057940e-02
-7044, 5.082473e-02, -2.101923e-02, 4.327036e-02
-7045, -7.012369e-03, 5.455006e-02, 2.584207e-01
-7046, -4.598158e-02, -3.017376e-02, 3.394448e-01
-7047, -3.973942e-02, -3.706398e-02, 3.460606e-01
-7048, -3.259744e-02, -4.429783e-02, 3.380785e-01
-7049, -3.894687e-02, -3.757713e-02, 3.311888e-01
-7050, 4.951285e-02, -2.354035e-02, 4.814315e-01
-7051, 4.819678e-02, -2.648238e-02, 4.862754e-01
-7052, 3.128320e-02, -4.518430e-02, 4.953736e-01
-7053, 2.699153e-02, -4.785904e-02, 4.950603e-01
-7054, 2.898913e-02, -4.645994e-02, 4.900394e-01
-7055, 1.916416e-02, 5.131430e-02, 6.406448e-02
-7056, 5.191474e-02, -1.611827e-02, 4.243672e-01
-7057, 5.173206e-02, -1.712908e-02, 4.190138e-01
-7058, 5.145808e-02, -1.838288e-02, 1.718593e-01
-7059, 5.372894e-02, -1.175506e-02, 1.671344e-01
-7060, 1.568840e-02, -5.167521e-02, 4.049094e-01
-7061, -3.879805e-02, -3.894536e-02, 2.352851e-02
-7062, -3.439518e-02, -4.276659e-02, 2.196351e-02
-7063, -3.446391e-02, -4.270243e-02, 2.937107e-02
-7064, -5.482438e-02, 4.337704e-03, 4.945254e-01
-7065, -5.455092e-02, 6.828925e-03, 4.895159e-01
-7066, 5.188188e-02, -1.752361e-02, 4.268467e-01
-7067, 5.459852e-02, -4.891611e-03, 4.079609e-01
-7068, 5.500000e-02, -1.347111e-17, 4.103745e-01
-7069, 5.679688e-02, -6.608615e-03, 4.217403e-01
-7070, 5.718812e-02, -1.779419e-03, 4.194904e-01
-7071, -3.550350e-03, 5.487579e-02, 1.731515e-02
-7072, 5.168092e-02, -1.801740e-02, 4.408662e-01
-7073, 5.186218e-02, -1.760956e-02, 4.323747e-01
-7074, 4.945640e-02, -2.394235e-02, 4.296790e-01
-7075, 5.376600e-02, -1.155947e-02, 4.381309e-01
-7076, 5.673693e-02, 3.403960e-03, 4.165510e-01
-7077, 6.314278e-03, 5.462216e-02, 4.548736e-01
-7078, 1.386100e-02, 5.319834e-02, 4.547588e-01
-7079, 5.500000e-02, -1.347111e-17, 3.998604e-01
-7080, 1.658557e-02, 5.243491e-02, 4.947423e-01
-7081, 1.907837e-02, 5.145654e-02, 4.897927e-01
-7082, -1.776812e-03, 5.495378e-02, 4.893194e-01
-7083, -3.172784e-02, 4.486454e-02, 4.889269e-01
-7084, 2.761647e-02, -4.733675e-02, 4.589647e-01
-7085, 3.551809e-02, -4.154207e-02, 4.600465e-01
-7086, -5.447909e-02, 5.851346e-03, 3.190017e-02
-7087, -5.314338e-02, 1.391026e-02, 3.194414e-02
-7088, 2.618144e-02, 4.832113e-02, 4.852749e-01
-7089, 2.829727e-02, 4.690376e-02, 4.900445e-01
-7090, 2.371055e-02, 4.961830e-02, 4.901035e-01
-7091, 1.610930e-02, 5.195594e-02, 3.238615e-01
-7092, 5.248242e-02, 1.603017e-02, 1.137861e-01
-7093, 5.260776e-02, 1.544462e-02, 1.082984e-01
-7094, -5.420442e-02, 8.451047e-03, 1.598054e-01
-7095, -5.458373e-02, -2.622414e-03, 1.468308e-01
-7096, 5.029151e-02, 2.215602e-02, 6.702252e-02
-7097, 5.031302e-02, 2.210174e-02, 7.268443e-02
-7098, 2.877220e-02, 4.687046e-02, 4.804529e-01
-7099, 3.088803e-02, 4.545309e-02, 4.852225e-01
-7100, 2.597215e-02, 4.844500e-02, 4.950531e-01
-7101, 4.636454e-02, -2.942903e-02, 2.260533e-02
-7102, 4.956126e-02, -2.343473e-02, 1.831509e-02
-7103, 4.761622e-02, -2.752089e-02, 1.576303e-02
-7104, -4.284865e-02, -3.444790e-02, 4.948295e-01
-7105, -4.116166e-02, -3.645422e-02, 4.901100e-01
-7106, 5.500000e-02, -1.347111e-17, 3.926259e-02
-7107, 5.021984e-02, -2.240541e-02, 4.955958e-01
-7108, 2.210566e-02, -5.023901e-02, 4.858054e-01
-7109, 2.668002e-02, -4.805212e-02, 4.847444e-01
-7110, 4.705732e-02, 2.810646e-02, 4.275855e-01
-7111, 4.795495e-02, 2.675669e-02, 4.219230e-01
-7112, 2.448299e-02, 4.909965e-02, 4.791715e-01
-7113, 2.201210e-02, 5.039682e-02, 4.840001e-01
-7114, 4.866452e-02, -2.555939e-02, 3.839210e-01
-7115, 4.373926e-02, -3.277728e-02, 3.788398e-01
-7116, 4.882616e-02, -2.522165e-02, 3.764678e-01
-7117, -5.430506e-02, 7.556421e-03, 4.784819e-01
-7118, 5.485148e-02, -2.981480e-03, 4.848627e-01
-7119, 5.500000e-02, -1.347111e-17, 4.609149e-01
-7120, 5.500000e-02, -1.347111e-17, 4.663150e-01
-7121, 5.465243e-02, -4.553364e-03, 4.633155e-01
-7122, 2.448765e-02, -4.924304e-02, 4.904331e-01
-7123, -2.528323e-03, -5.486328e-02, 1.354641e-01
-7124, 7.116307e-03, -5.398974e-02, 1.390404e-01
-7125, 8.854955e-03, -5.340990e-02, 1.313287e-01
-7126, -5.465851e-02, 2.779944e-03, 4.212097e-02
-7127, -1.327340e-02, 5.222665e-02, 1.306324e-01
-7128, -7.811688e-03, 5.428646e-02, 1.431341e-01
-7129, -1.761242e-02, 5.162298e-02, 1.419606e-01
-7130, 5.457780e-02, 5.015362e-03, 9.181628e-02
-7131, -5.419109e-02, 9.249574e-03, 4.255888e-02
-7132, 5.128491e-02, -1.896979e-02, 3.866272e-01
-7133, 5.144655e-02, -1.863206e-02, 3.791740e-01
-7134, 3.830392e-02, 3.943262e-02, 2.747072e-01
-7135, 4.281079e-02, 3.422077e-02, 2.792960e-01
-7136, 3.651509e-02, 4.095040e-02, 2.846219e-01
-7137, 7.218061e-04, -5.485332e-02, 4.698855e-01
-7138, 5.386366e-02, 1.098206e-02, 2.993628e-01
-7139, 3.847939e-04, -5.487801e-02, 4.777384e-01
-7140, 5.737287e-03, -5.465424e-02, 4.788111e-01
-7141, 1.283618e-02, -5.320834e-02, 4.854912e-01
-7142, -5.492104e-02, 1.274061e-03, 3.896576e-01
-7143, -5.473595e-02, -1.484331e-03, 3.784810e-01
-7144, -5.448004e-02, -7.423875e-03, 3.890384e-01
-7145, 5.393732e-02, -1.071581e-02, 6.666917e-02
-7146, 5.451502e-02, -5.372499e-03, 6.407228e-02
-7147, 5.035442e-02, 2.200811e-02, 3.639482e-01
-7148, 3.575591e-02, -4.177461e-02, 3.529635e-01
-7149, 2.744106e-02, -4.672191e-02, 3.480325e-01
-7150, 3.356307e-02, -4.227237e-02, 4.094372e-01
-7151, 2.485288e-02, -4.903998e-02, 4.100674e-01
-7152, 3.163899e-02, -4.436009e-02, 4.030146e-01
-7153, 3.053226e-02, -4.492802e-02, 3.928495e-01
-7154, 5.249671e-02, -1.577130e-02, 4.596765e-01
-7155, 3.886478e-02, 3.869592e-02, 4.825105e-03
-7156, 3.502806e-02, 4.236979e-02, 4.707247e-03
-7157, 1.383821e-02, 5.320291e-02, 8.804674e-03
-7158, 1.625114e-02, 5.253427e-02, 4.170435e-03
-7159, 2.276653e-02, -4.991202e-02, 1.728846e-02
-7160, 1.204377e-02, -5.366514e-02, 5.484162e-03
-7161, -3.731622e-02, 4.039864e-02, 4.298954e-03
-7162, -3.291468e-02, 4.405577e-02, 5.001033e-03
-7163, -3.473353e-02, 4.253880e-02, 9.299987e-03
-7164, 4.231825e-02, 3.512851e-02, 4.825105e-03
-7165, 4.051351e-02, 3.713960e-02, 1.072153e-02
-7166, 4.402175e-02, 3.283420e-02, 1.042102e-02
-7167, -4.917578e-02, 2.461236e-02, 1.687552e-02
-7168, -5.031752e-02, 2.178079e-02, 1.195073e-02
-7169, 4.742382e-02, 2.783684e-02, 2.738131e-02
-7170, 4.482212e-02, 3.171154e-02, 2.205859e-02
-7171, 4.387123e-02, 3.314409e-02, 2.855189e-02
-7172, -8.359825e-03, -5.430389e-02, 1.693680e-02
-7173, -8.523465e-03, -5.427125e-02, 2.411713e-02
-7174, -3.053195e-02, -4.571461e-02, 2.291827e-02
-7175, -4.537702e-02, 3.098171e-02, 2.711112e-02
-7176, -1.224125e-02, 5.284253e-02, 4.132109e-01
-7177, -5.122475e-02, 1.963658e-02, 2.358577e-02
-7178, -5.275811e-02, 1.544424e-02, 1.665732e-02
-7179, -5.110690e-02, 2.000790e-02, 1.538956e-02
-7180, 1.773616e-02, -5.205917e-02, 6.491944e-03
-7181, -2.208198e-02, -5.006812e-02, 4.690162e-02
-7182, -2.140396e-02, -5.044753e-02, 3.877053e-02
-7183, -3.827278e-02, 3.834042e-02, 2.455169e-01
-7184, -3.476689e-02, 4.246518e-02, 2.331740e-01
-7185, 5.119797e-02, -1.890545e-02, 3.132322e-01
-7186, 5.500000e-02, -1.347111e-17, 4.825269e-01
-7187, 5.238313e-02, 6.028908e-04, 2.899747e-03
-7188, -6.231687e-03, 5.448975e-02, 4.632488e-01
-7189, 4.067323e-02, -3.701310e-02, 9.014077e-03
-7190, 4.099520e-02, -3.666363e-02, 1.558522e-02
-7191, 1.673845e-03, 5.478455e-02, 4.721807e-01
-7192, 5.214691e-02, 1.747645e-02, 2.531779e-02
-7193, 5.003671e-02, 2.269932e-02, 2.633592e-02
-7194, 5.314851e-02, 1.361788e-02, 2.925748e-02
-7195, -4.592734e-02, -3.019907e-02, 4.949576e-01
-7196, -2.112614e-02, 5.047454e-02, 4.421793e-01
-7197, 5.440818e-02, -5.929500e-03, 4.405074e-01
-7198, 5.500000e-02, -1.347111e-17, 4.380011e-01
-7199, 5.043771e-02, 2.182812e-02, 1.736487e-01
-7200, 5.041534e-02, 2.188514e-02, 1.679689e-01
-7201, -5.252142e-02, -1.600445e-02, 4.712183e-01
-7202, 5.230477e-02, 1.647933e-02, 1.641167e-01
-7203, -4.042511e-02, -3.708061e-02, 1.624008e-02
-7204, -5.062223e-02, -2.137177e-02, 4.946598e-01
-7205, 6.852935e-03, -5.456105e-02, 6.501356e-03
-7206, -4.518317e-02, 3.135884e-02, 1.129319e-01
-7207, 1.988908e-02, -5.109640e-02, 1.342551e-01
-7208, 1.841757e-02, -5.174648e-02, 1.481302e-01
-7209, 5.500000e-02, -1.347111e-17, 9.982196e-02
-7210, 5.465042e-02, -4.566486e-03, 1.026520e-01
-7211, 4.743525e-02, 2.709468e-02, 9.732810e-02
-7212, 5.228966e-02, 1.647532e-02, 6.369970e-02
-7213, 5.032779e-02, 2.208230e-02, 6.054525e-02
-7214, 5.226292e-02, 1.659256e-02, 2.305238e-01
-7215, 4.420705e-03, -5.469507e-02, 1.212664e-02
-7216, 9.731895e-03, -5.409006e-02, 1.198552e-02
-7217, 5.135955e-02, -1.865044e-02, 3.922216e-01
-7218, 5.372011e-02, -1.179095e-02, 3.885415e-01
-7219, 4.726538e-02, 2.780738e-02, 4.343398e-01
-7220, 4.263099e-02, 3.443439e-02, 4.396314e-01
-7221, 5.414485e-02, -9.565497e-03, 4.608500e-01
-7222, -3.148584e-03, -5.481676e-02, 5.625281e-03
-7223, -8.495457e-04, -5.498259e-02, 1.176779e-02
-7224, 1.814693e-03, -5.495371e-02, 5.625281e-03
-7225, 2.402338e-02, 4.940332e-02, 4.391178e-01
-7226, 7.358813e-03, -5.450315e-02, 1.845030e-02
-7227, 1.713541e-02, 5.222776e-02, 1.102269e-01
-7228, 4.440037e-03, 5.401032e-02, 1.162813e-01
-7229, -3.606191e-02, -4.152658e-02, 4.652986e-01
-7230, 5.197602e-02, -1.703602e-02, 2.247117e-01
-7231, 4.932547e-02, -2.429643e-02, 2.196775e-01
-7232, 4.923850e-02, -2.446254e-02, 2.273711e-01
-7233, -5.787904e-03, 5.464052e-02, 1.212969e-01
-7234, 5.259330e-02, 1.523116e-02, 2.857705e-01
-7235, 5.240458e-02, 1.617410e-02, 2.909057e-01
-7236, 5.083317e-02, 2.095464e-02, 2.861672e-01
-7237, 5.454264e-02, 5.218467e-03, 3.743837e-01
-7238, 5.453631e-02, 5.254168e-03, 8.637766e-02
-7239, 5.220159e-02, -1.692702e-02, 3.666254e-01
-7240, 9.972284e-03, 5.396655e-02, 1.689660e-01
-7241, -4.593182e-02, -3.019272e-02, 4.842415e-01
-7242, -4.706935e-02, -2.808800e-02, 4.785348e-01
-7243, 5.455731e-02, 5.134700e-03, 3.799775e-01
-7244, 5.390483e-02, 1.080907e-02, 3.772395e-01
-7245, -5.427397e-02, -8.903308e-03, 3.267324e-01
-7246, 5.386345e-02, 1.098380e-02, 3.832862e-01
-7247, -4.453931e-02, 3.221267e-02, 4.854373e-01
-7248, 5.202635e-02, -1.680767e-02, 2.188069e-01
-7249, 6.742924e-03, 5.385094e-02, 3.733472e-01
-7250, 5.723910e-02, -1.839515e-03, 2.911170e-01
-7251, 5.500000e-02, -1.347111e-17, 2.884200e-01
-7252, 3.071863e-02, 4.542740e-02, 2.781853e-01
-7253, 1.332220e-02, 5.335809e-02, 3.421024e-01
-7254, 5.231197e-02, 1.641743e-02, 7.509020e-02
-7255, 5.394813e-02, 1.064521e-02, 7.806625e-02
-7256, 5.238236e-02, 1.608818e-02, 8.055919e-02
-7257, -3.109860e-02, 4.535200e-02, 2.724935e-01
-7258, -3.749075e-02, 3.930952e-02, 2.850948e-01
-7259, 5.500000e-02, -1.347111e-17, 1.553211e-01
-7260, 5.500000e-02, -1.347111e-17, 1.611672e-01
-7261, 5.383436e-02, -1.120973e-02, 4.439881e-01
-7262, 5.230261e-02, 1.652238e-02, 4.421645e-01
-7263, 4.750780e-02, 2.746862e-02, 1.707663e-01
-7264, 4.660870e-02, 2.875141e-02, 1.652730e-01
-7265, 5.025788e-02, 2.218836e-02, 8.458586e-02
-7266, 5.039945e-02, 2.194091e-02, 4.307581e-01
-7267, -4.266541e-02, -3.469825e-02, 4.731308e-01
-7268, 5.453631e-02, 5.254168e-03, 8.050920e-02
-7269, 5.500000e-02, -1.347111e-17, 2.108043e-01
-7270, 5.413111e-02, 9.733150e-03, 2.055067e-01
-7271, 5.500000e-02, -1.347111e-17, 1.386993e-01
-7272, 1.282404e-02, -5.318405e-02, 1.786119e-02
-7273, 5.500000e-02, -1.347111e-17, 2.058211e-01
-7274, 5.461560e-02, -4.787084e-03, 2.076550e-01
-7275, -4.904133e-02, -2.434533e-02, 4.241533e-02
-7276, -1.598769e-02, -5.242081e-02, 1.011691e-01
-7277, -2.098303e-02, -4.967455e-02, 9.053242e-02
-7278, -2.207375e-02, -5.036083e-02, 1.147261e-01
-7279, -2.706909e-02, -4.761457e-02, 1.040894e-01
-7280, 5.455235e-02, 5.163180e-03, 2.031828e-01
-7281, 5.455738e-02, 5.134296e-03, 3.247386e-01
-7282, 5.389461e-02, 1.085264e-02, 3.218443e-01
-7283, 5.454670e-02, 5.195408e-03, 3.192904e-01
-7284, -2.361016e-02, 4.922457e-02, 1.823960e-01
-7285, -1.790492e-02, 5.036534e-02, 1.912281e-01
-7286, -2.899715e-02, 4.673474e-02, 1.932877e-01
-7287, -4.663134e-02, -2.808367e-02, 1.728144e-01
-7288, -4.759769e-02, -2.520720e-02, 1.621797e-01
-7289, 5.402996e-02, 1.024245e-02, 3.275676e-01
-7290, 4.808271e-02, 2.660190e-02, 2.115206e-02
-7291, 5.455738e-02, 5.134296e-03, 3.299845e-01
-7292, 5.408839e-02, 9.934644e-03, 1.055426e-01
-7293, 2.618940e-02, 4.828198e-02, 4.538302e-03
-7294, -4.829393e-02, 2.595677e-02, 4.806170e-01
-7295, -5.055474e-02, 2.166131e-02, 4.798069e-01
-7296, -4.968572e-02, 2.347588e-02, 4.730400e-01
-7297, 5.397949e-02, 1.046977e-02, 2.882122e-01
-7298, 5.397278e-02, 1.050855e-02, 2.936693e-01
-7299, 4.554064e-02, 3.083868e-02, 2.722927e-01
-7300, 3.704528e-02, -4.044542e-02, 4.902199e-01
-7301, -4.842791e-02, -2.597169e-02, 4.947931e-01
-7302, -4.016128e-02, -3.685932e-02, 2.937202e-01
-7303, 1.344043e-02, -5.298657e-02, 4.621168e-01
-7304, 5.467077e-02, 4.043872e-03, 4.583218e-01
-7305, 5.423560e-02, 9.135117e-03, 4.557609e-01
-7306, 5.427969e-02, 8.872104e-03, 4.614125e-01
-7307, 5.500000e-02, -1.347111e-17, 4.555149e-01
-7308, 5.456483e-02, 5.091246e-03, 4.529540e-01
-7309, -2.295407e-02, -4.865667e-02, 8.115285e-02
-7310, -1.744712e-02, -5.184889e-02, 7.091003e-02
-7311, -5.284982e-02, 1.574698e-02, 1.605826e-01
-7312, -5.284353e-02, 1.289066e-02, 1.461695e-01
-7313, -2.560346e-02, -4.863536e-02, 4.626986e-01
-7314, 3.915199e-02, -3.862799e-02, 2.340222e-01
-7315, 4.433175e-02, -3.155507e-02, 2.292677e-01
-7316, 5.399705e-02, 1.038903e-02, 4.504739e-01
-7317, -3.923737e-02, -3.830447e-02, 4.853084e-01
-7318, 4.200789e-02, 3.502757e-02, 1.498476e-01
-7319, 4.700298e-02, 2.836062e-02, 1.534559e-01
-7320, 4.633399e-02, 2.930128e-02, 1.590491e-01
-7321, 4.133890e-02, 3.596823e-02, 1.554408e-01
-7322, 5.456483e-02, 5.091246e-03, 4.469525e-01
-7323, 3.751825e-02, 3.986508e-02, 2.108412e-01
-7324, 3.722395e-02, 4.009382e-02, 2.209177e-01
-7325, 5.500000e-02, -1.347111e-17, 1.774601e-01
-7326, 5.471657e-02, -4.114048e-03, 1.804462e-01
-7327, 5.215131e-02, 1.694225e-02, 2.418889e-01
-7328, 5.222451e-02, 1.675988e-02, 2.364371e-01
-7329, 5.002111e-02, 2.272954e-02, 2.395315e-01
-7330, 5.500000e-02, -1.347111e-17, 1.828276e-01
-7331, 5.471657e-02, -4.114048e-03, 1.858137e-01
-7332, 5.380398e-02, -1.137259e-02, 1.785560e-01
-7333, 5.236668e-02, -1.620789e-02, 3.555892e-01
-7334, -3.951040e-02, -3.803045e-02, 4.669335e-01
-7335, -5.219061e-02, 1.664979e-02, 4.796437e-01
-7336, -4.429609e-02, -3.230945e-02, 4.897871e-01
-7337, 3.737739e-02, -4.033496e-02, 4.792515e-01
-7338, 5.460876e-02, -4.829195e-03, 4.247739e-01
-7339, 5.411343e-02, -9.781106e-03, 4.218670e-01
-7340, 5.393075e-02, -1.079191e-02, 4.165136e-01
-7341, -3.553510e-02, 4.197921e-02, 2.078143e-02
-7342, 5.412339e-02, -9.775537e-03, 3.825844e-02
-7343, -3.201904e-02, -4.471647e-02, 4.697157e-03
-7344, 4.705590e-02, -2.842835e-02, 4.807464e-01
-7345, 2.469345e-02, -4.914465e-02, 1.767405e-01
-7346, 2.269315e-02, -5.005186e-02, 1.626061e-01
-7347, -4.801833e-02, 2.663709e-02, 2.579142e-02
-7348, -4.653446e-02, 2.895698e-02, 1.819522e-02
-7349, -1.978343e-03, 5.471287e-02, 3.049103e-02
-7350, 5.400211e-02, 1.040028e-02, 3.331514e-01
-7351, 5.233843e-02, 1.622094e-02, 3.302987e-01
-7352, 5.084560e-02, 2.092237e-02, 2.806003e-01
-7353, 5.260573e-02, 1.519889e-02, 2.802035e-01
-7354, 4.471657e-02, 3.196292e-02, 3.487122e-01
-7355, -5.131445e-02, 1.967164e-02, 4.938561e-03
-7356, -4.914886e-02, 2.443171e-02, 4.848064e-03
-7357, 4.138671e-02, -3.619068e-02, 4.052371e-01
-7358, 4.203293e-02, -3.546554e-02, 4.143042e-01
-7359, 4.672411e-02, -2.806913e-02, 4.093659e-01
-7360, 1.998150e-02, -5.061848e-02, 5.586342e-02
-7361, 1.116054e-02, -5.380503e-02, 6.027140e-02
-7362, -1.415556e-02, 5.202353e-02, 1.016166e-01
-7363, 5.454962e-02, -5.178804e-03, 3.601056e-02
-7364, -2.739185e-02, -4.738177e-02, 1.250053e-01
-7365, -1.521590e-02, -5.208636e-02, 1.245217e-01
-7366, -5.496409e-02, -4.066470e-04, 1.757322e-02
-7367, -5.450007e-02, -6.047082e-03, 1.753344e-02
-7368, -4.322917e-02, 3.346159e-02, 3.386080e-02
-7369, -5.392793e-02, -1.080583e-02, 1.581505e-02
-7370, -5.427374e-02, -8.500118e-03, 1.000478e-02
-7371, 3.953104e-03, -5.479533e-02, 2.523060e-02
-7372, 1.494055e-03, -5.458946e-02, 6.052782e-02
-7373, -5.090547e-02, 2.028295e-02, 3.108352e-02
-7374, -5.482140e-02, 1.589121e-03, 1.165082e-02
-7375, 3.404926e-03, -5.488773e-02, 1.117429e-01
-7376, 1.200638e-03, -5.497483e-02, 1.259938e-01
-7377, -1.148694e-02, -5.219791e-02, 1.150514e-01
-7378, -5.490787e-02, -9.569974e-04, 8.976226e-02
-7379, -5.332693e-02, -8.821626e-03, 9.665533e-02
-7380, -5.467916e-02, 5.075250e-03, 1.787075e-02
-7381, -5.453646e-02, 7.071018e-03, 1.194835e-02
-7382, 4.555579e-02, -3.046611e-02, 1.125592e-01
-7383, 4.856090e-02, -2.578144e-02, 1.076546e-01
-7384, 4.919470e-02, -2.439320e-02, 1.128854e-01
-7385, 3.813098e-02, 3.961059e-02, 2.605737e-01
-7386, 4.335546e-02, 3.329365e-02, 2.597252e-01
-7387, 4.224632e-02, 3.495976e-02, 2.544626e-01
-7388, -3.575148e-02, -4.145202e-02, 2.333057e-01
-7389, 4.815053e-02, 2.656191e-02, 4.695294e-03
-7390, 4.515427e-02, 3.138657e-02, 5.595919e-03
-7391, 5.042859e-02, -2.180563e-02, 1.020755e-01
-7392, 3.644533e-02, 4.100280e-02, 5.623596e-02
-7393, 4.292785e-02, 3.405119e-02, 5.385362e-02
-7394, 3.046562e-02, 4.571305e-02, 4.949914e-01
-7395, 5.228583e-02, 1.662134e-02, 3.189209e-01
-7396, -9.452730e-03, -5.391057e-02, 4.771219e-01
-7397, -6.374408e-03, -5.457003e-02, 4.698086e-01
-7398, -4.391290e-03, -5.481967e-02, 4.767463e-01
-7399, 5.250186e-02, 1.536335e-02, 3.355243e-01
-7400, 5.232122e-02, 1.580602e-02, 3.411129e-01
-7401, 3.814747e-02, 3.871922e-02, 3.465470e-01
-7402, 5.067957e-02, -2.131959e-02, 3.405929e-01
-7403, 4.273416e-02, 3.458410e-02, 3.411859e-01
-7404, 3.244543e-02, 4.439770e-02, 3.423595e-01
-7405, 5.264470e-02, -1.518082e-02, 3.477370e-02
-7406, 3.282120e-02, 4.382759e-02, 4.793975e-01
-7407, 2.896716e-02, 4.675258e-02, 4.738534e-01
-7408, -1.621762e-02, -5.202660e-02, 3.353170e-01
-7409, -1.923231e-02, -5.132024e-02, 3.205641e-01
-7410, -6.719503e-03, -5.420514e-02, 3.240306e-01
-7411, 5.027804e-02, 2.214561e-02, 3.224872e-01
-7412, 5.242118e-02, 1.601114e-02, 3.246442e-01
-7413, 4.854910e-02, -2.584526e-02, 2.746299e-01
-7414, 4.410538e-02, -3.184706e-02, 2.716422e-01
-7415, -5.157770e-02, 1.889616e-02, 4.734224e-01
-7416, -5.298441e-02, 1.458827e-02, 4.713998e-01
-7417, -5.428694e-02, 7.813261e-03, 4.708322e-01
-7418, 1.217534e-03, -5.495425e-02, 1.613440e-01
-7419, 9.953946e-04, -5.496653e-02, 1.709543e-01
-7420, 1.115457e-02, -5.239994e-02, 1.678450e-01
-7421, 4.272528e-02, 3.434564e-02, 2.900753e-01
-7422, 5.456455e-02, 5.092896e-03, 2.857451e-01
-7423, 4.592521e-02, -2.992444e-02, 2.817196e-01
-7424, 5.174816e-02, -6.769610e-03, 2.938593e-01
-7425, 5.394958e-02, -1.069687e-02, 2.936016e-01
-7426, -5.226813e-02, -1.555064e-02, 2.687275e-01
-7427, 3.285055e-02, -4.355638e-02, 3.297542e-01
-7428, 5.455731e-02, 5.134700e-03, 3.856003e-01
-7429, 4.215348e-02, 3.500565e-02, 4.237903e-01
-7430, 4.305111e-02, 3.365588e-02, 4.181279e-01
-7431, 4.804676e-02, 2.662134e-02, 4.012255e-01
-7432, 5.054297e-02, 2.155986e-02, 4.040142e-01
-7433, 4.725764e-02, 2.783504e-02, 4.066333e-01
-7434, -1.316821e-02, 5.335080e-02, 4.545544e-01
-7435, -6.090767e-03, 5.449581e-02, 4.547367e-01
-7436, -5.330221e-02, 1.330237e-02, 4.533300e-01
-7437, -5.445625e-02, 7.013056e-03, 4.627107e-01
-7438, 4.236463e-02, -3.401820e-02, 2.174819e-01
-7439, 4.441872e-02, -3.138896e-02, 2.215740e-01
-7440, -5.119964e-02, 1.955389e-02, 4.450267e-01
-7441, 3.268056e-02, 4.366331e-02, 4.508243e-01
-7442, 3.220734e-02, 4.382084e-02, 4.427349e-01
-7443, 3.858397e-02, 3.918203e-02, 4.446850e-01
-7444, 4.336235e-02, -3.304054e-02, 2.078395e-01
-7445, 5.249976e-02, -1.578056e-02, 2.546413e-01
-7446, 5.500000e-02, -1.347111e-17, 3.715464e-01
-7447, 2.190328e-02, 4.951879e-02, 3.427661e-01
-7448, 5.405142e-02, 1.016837e-02, 3.552528e-01
-7449, 5.450275e-02, 5.439450e-03, 3.528794e-01
-7450, 5.453895e-02, 5.239296e-03, 3.583279e-01
-7451, 5.265223e-02, 1.502990e-02, 2.637504e-01
-7452, 5.094093e-02, 2.069558e-02, 2.635404e-01
-7453, 5.106240e-02, -2.041738e-02, 1.073063e-01
-7454, -4.896751e-02, -2.503439e-02, 3.878299e-01
-7455, -5.153559e-02, -1.739235e-02, 3.984612e-01
-7456, -4.629840e-02, -2.907984e-02, 4.012386e-01
-7457, -5.191197e-02, -1.506592e-02, 3.784072e-01
-7458, 5.412635e-02, -9.709445e-03, 1.221603e-01
-7459, 5.234215e-02, -1.611915e-02, 1.223342e-01
-7460, 5.378891e-02, -1.146276e-02, 1.165419e-01
-7461, 5.220083e-02, -1.677729e-02, 1.277823e-01
-7462, -5.199177e-02, -1.792456e-02, 9.923651e-03
-7463, -5.255745e-02, -1.592276e-02, 4.544932e-03
-7464, -5.315847e-02, -1.374236e-02, 9.944466e-03
-7465, -5.372415e-02, -1.174056e-02, 4.565747e-03
-7466, -2.230602e-02, 4.999383e-02, 1.709011e-01
-7467, -3.967528e-02, 3.808335e-02, 4.426197e-02
-7468, -3.596829e-02, 4.117230e-02, 5.138380e-02
-7469, -4.333689e-02, 3.285568e-02, 2.229833e-01
-7470, -4.684279e-02, 2.873092e-02, 2.353263e-01
-7471, -5.043373e-02, 2.065127e-02, 2.247267e-01
-7472, 3.005337e-02, -4.463005e-02, 2.386744e-01
-7473, -1.916133e-02, 5.147421e-02, 1.761661e-02
-7474, -2.382294e-02, 4.950033e-02, 1.621051e-02
-7475, 4.540882e-02, -2.988913e-02, 2.449232e-01
-7476, -3.209940e-02, 4.399757e-02, 3.398828e-02
-7477, -3.469889e-02, 4.244821e-02, 4.152614e-02
-7478, -2.748909e-02, 4.749525e-02, 4.908768e-02
-7479, -1.091772e-02, -5.390439e-02, 1.056658e-02
-7480, 8.651284e-03, -5.352236e-02, 2.131970e-01
-7481, 8.204427e-03, -5.367842e-02, 2.222181e-01
-7482, 4.045668e-03, 5.485044e-02, 3.065803e-02
-7483, 8.858255e-03, 5.404208e-02, 2.778145e-02
-7484, 1.466516e-02, 5.300802e-02, 2.546220e-02
-7485, 5.428848e-03, 5.471661e-02, 2.288531e-02
-7486, 2.095323e-04, 5.481920e-02, 2.396627e-02
-7487, 1.123575e-02, 5.368255e-02, 2.056606e-02
-7488, 4.148150e-02, -3.592625e-02, 2.787319e-01
-7489, 3.308869e-02, -4.342977e-02, 2.762941e-01
-7490, 3.857387e-02, -3.920406e-02, 2.709860e-01
-7491, -4.887351e-02, -2.506808e-02, 2.509839e-02
-7492, 5.391089e-02, 1.082406e-02, 2.332917e-01
-7493, 5.387249e-02, 1.099138e-02, 2.392050e-01
-7494, 4.237695e-02, 3.459341e-02, 3.222863e-01
-7495, 5.500000e-02, -1.347111e-17, 2.604657e-01
-7496, 4.679007e-02, 2.845224e-02, 2.114056e-01
-7497, -9.115953e-03, -5.338277e-02, 1.669045e-01
-7498, -5.186643e-02, -1.776320e-02, 2.277848e-02
-7499, -2.469130e-02, 4.913468e-02, 4.941522e-01
-7500, 5.253058e-02, 1.546472e-02, 2.026502e-01
-7501, 4.609948e-02, 2.999695e-02, 1.996632e-01
-7502, 4.369960e-02, 3.335767e-02, 1.810380e-01
-7503, 4.532019e-02, 3.113059e-02, 1.882745e-01
-7504, 5.228757e-02, 1.666757e-02, 3.806605e-01
-7505, 1.850868e-02, 5.177093e-02, 3.069450e-01
-7506, -4.599368e-02, -3.003263e-02, 4.578241e-01
-7507, 3.302540e-02, -4.349260e-02, 2.834189e-01
-7508, 2.601218e-02, -4.837578e-02, 2.894554e-01
-7509, -2.240472e-02, -5.021622e-02, 2.046797e-01
-7510, 5.394254e-02, 1.067654e-02, 7.240381e-02
-7511, 3.448372e-03, 5.382063e-02, 2.165604e-01
-7512, 5.454405e-02, 5.210501e-03, 2.191717e-01
-7513, 5.461506e-02, -4.790432e-03, 1.254276e-01
-7514, 5.500000e-02, -1.347111e-17, 6.659429e-02
-7515, 5.179196e-02, 6.615120e-03, 4.971926e-01
-7516, 4.648240e-02, -2.893924e-02, 6.054747e-02
-7517, 4.309154e-02, -3.413921e-02, 6.307259e-02
-7518, 5.242677e-02, 1.612395e-02, 5.781817e-02
-7519, 5.049669e-02, -2.166216e-02, 6.041433e-02
-7520, 3.857810e-02, -3.877226e-02, 4.033929e-02
-7521, 1.054080e-02, -5.380323e-02, 3.673364e-01
-7522, 1.533471e-02, -5.281891e-02, 3.564342e-01
-7523, 7.961714e-03, -5.392185e-02, 2.319249e-01
-7524, 1.930918e-02, -5.143336e-02, 2.379957e-01
-7525, 5.223617e-02, 1.656508e-02, 2.474940e-01
-7526, 5.390776e-02, 1.079161e-02, 2.445725e-01
-7527, 5.399262e-02, 1.041444e-02, 2.501775e-01
-7528, 5.240562e-02, 1.613751e-02, 2.529453e-01
-7529, 5.400170e-02, 1.036168e-02, 2.557270e-01
-7530, 5.008119e-02, 2.258484e-02, 1.562839e-01
-7531, 5.224533e-02, 1.662916e-02, 1.586555e-01
-7532, 5.014063e-02, 2.243501e-02, 1.617450e-01
-7533, 1.783579e-02, 5.191891e-02, 7.466882e-02
-7534, 3.070353e-02, -4.487731e-02, 1.833078e-01
-7535, 3.333675e-02, -4.312725e-02, 1.602568e-01
-7536, 3.898271e-02, -3.877696e-02, 4.952408e-01
-7537, 1.805811e-02, 5.182419e-02, 5.499576e-02
-7538, -4.826810e-02, 2.628255e-02, 4.546250e-01
-7539, 5.153381e-02, -1.902128e-02, 2.497065e-02
-7540, 5.203895e-02, -1.775958e-02, 1.735519e-02
-7541, 4.905612e-02, -2.469643e-02, 2.593055e-02
-7542, 4.842151e-02, 2.579267e-02, 2.609129e-01
-7543, 4.753565e-02, 2.761483e-02, 2.543224e-01
-7544, 4.755369e-02, 2.716941e-02, 2.887532e-01
-7545, 4.762963e-02, 2.743305e-02, 3.007220e-01
-7546, 4.996888e-02, 2.269317e-02, 3.048978e-01
-7547, 5.014617e-02, 2.236160e-02, 2.981093e-01
-7548, -3.418657e-02, 4.287459e-02, 2.181941e-01
-7549, 5.232153e-02, 1.652938e-02, 3.134958e-01
-7550, 5.468558e-02, 4.332016e-03, 3.019127e-02
-7551, 5.253304e-02, 1.543308e-02, 4.250235e-01
-7552, 5.249910e-02, 1.560968e-02, 9.181367e-02
-7553, -6.497029e-03, -5.458932e-02, 4.519449e-01
-7554, -1.419628e-03, -5.461971e-02, 4.618994e-01
-7555, -8.515842e-03, -5.433641e-02, 4.618225e-01
-7556, 5.142160e-02, -1.873480e-02, 3.735510e-01
-7557, 4.238031e-02, 3.467919e-02, 4.125240e-01
-7558, 5.729138e-02, 1.643076e-03, 4.911156e-01
-7559, 5.704234e-02, -2.214436e-03, 4.927626e-01
-7560, -5.152458e-02, 1.918113e-02, 4.002873e-01
-7561, -1.691189e-02, 5.208118e-02, 1.114307e-02
-7562, -1.924454e-02, 5.143884e-02, 4.945142e-03
-7563, -2.191430e-02, 5.044445e-02, 1.116556e-02
-7564, 4.994145e-02, 2.276444e-02, 3.105511e-01
-7565, 4.990575e-02, 2.285640e-02, 3.159762e-01
-7566, 5.302889e-02, 1.424998e-02, 3.479383e-02
-7567, 5.460866e-02, 4.829844e-03, 3.565147e-02
-7568, 5.500000e-02, -1.347111e-17, 3.291878e-02
-7569, 5.021424e-02, 2.229943e-02, 7.885382e-02
-7570, -1.411116e-02, -5.287746e-02, 4.555776e-01
-7571, -6.782077e-04, -5.488261e-02, 4.125026e-01
-7572, 5.660106e-02, -9.904376e-03, 3.250501e-01
-7573, 5.217228e-02, -4.077961e-03, 3.221885e-01
-7574, 5.442878e-02, -5.826415e-03, 3.251063e-01
-7575, 5.380533e-02, -1.137473e-02, 3.275752e-01
-7576, -1.166165e-02, -5.297070e-02, 4.148632e-01
-7577, -2.979172e-03, -5.491001e-02, 4.223992e-01
-7578, 4.625825e-02, 2.973360e-02, 2.668554e-01
-7579, 4.103377e-02, 3.605053e-02, 2.677039e-01
-7580, 5.453742e-02, -5.247908e-03, 1.910520e-01
-7581, 4.792843e-02, 2.681173e-02, 4.122372e-01
-7582, 5.101878e-02, -2.050358e-02, 3.102866e-02
-7583, -1.233789e-02, -5.357415e-02, 3.139854e-02
-7584, 4.807568e-02, 2.619135e-02, 8.687150e-02
-7585, 4.789623e-03, -5.450056e-02, 8.949421e-02
-7586, 5.263856e-02, -1.521349e-02, 2.867154e-02
-7587, 2.550665e-02, -4.870222e-02, 1.015943e-01
-7588, -5.429727e-02, 1.222986e-03, 1.217865e-01
-7589, -5.437127e-02, -8.292471e-03, 1.355656e-01
-7590, 5.394377e-02, 1.069656e-02, 1.332415e-01
-7591, 4.722665e-02, -2.789744e-02, 4.483540e-02
-7592, 4.788652e-02, -2.642198e-02, 3.934199e-02
-7593, 5.016486e-02, -2.249470e-02, 4.876378e-02
-7594, -5.179382e-02, 1.745224e-02, 4.378299e-02
-7595, 5.395216e-02, 1.061265e-02, 4.167518e-01
-7596, 4.769471e-02, -2.687806e-02, 3.327599e-02
-7597, -2.171999e-02, -5.047954e-02, 1.584899e-01
-7598, -9.405853e-03, -5.327108e-02, 1.578393e-01
-7599, 1.572721e-03, -5.495538e-02, 1.467778e-01
-7600, -9.050665e-03, -5.327222e-02, 1.432731e-01
-7601, 4.229695e-02, 3.429831e-02, 1.099044e-01
-7602, 5.121059e-02, -2.004750e-02, 3.709466e-02
-7603, -3.758064e-02, 4.011274e-02, 4.532008e-01
-7604, -3.463316e-02, 4.239499e-02, 4.613006e-01
-7605, -5.400879e-03, -5.425789e-02, 1.014944e-01
-7606, -5.040396e-02, 2.142736e-02, 4.902504e-01
-7607, -5.145629e-02, 1.927289e-02, 4.853830e-01
-7608, 4.370185e-03, -5.482608e-02, 4.536054e-01
-7609, -1.210708e-02, -5.351251e-02, 4.697827e-01
-7610, -1.749758e-02, -5.212785e-02, 4.713512e-01
-7611, -7.072161e-04, -5.479570e-02, 4.436508e-01
-7612, -7.139842e-03, -5.427526e-02, 9.196214e-02
-7613, 2.435483e-03, -5.492832e-02, 4.841974e-01
-7614, -4.928850e-02, -2.399982e-02, 2.479084e-01
-7615, 4.839950e-02, 2.572419e-02, 4.588019e-01
-7616, 4.911993e-02, 2.452476e-02, 4.651990e-01
-7617, 5.041351e-02, -2.198346e-02, 4.090472e-01
-7618, 9.119405e-03, -5.378830e-02, 2.456000e-01
-7619, 2.159022e-02, -5.034709e-02, 2.498245e-01
-7620, 4.472912e-02, -3.118521e-02, 1.587770e-01
-7621, 4.884620e-02, -2.523716e-02, 3.898980e-01
-7622, 5.500000e-02, -1.347111e-17, 3.222446e-01
-7623, 5.500000e-02, -1.347111e-17, 3.274905e-01
-7624, 5.224611e-02, 1.625505e-02, 3.579938e-01
-7625, 5.500000e-02, -1.347111e-17, 9.460972e-02
-7626, -3.502175e-02, -4.217875e-02, 2.472626e-01
-7627, 4.162048e-02, -3.577922e-02, 9.048826e-02
-7628, 4.601229e-02, -2.977375e-02, 9.363231e-02
-7629, -2.128817e-02, -5.068058e-02, 1.733018e-01
-7630, 4.243294e-02, 3.486067e-02, 1.632118e-01
-7631, 3.237079e-02, -4.379699e-02, 8.903272e-02
-7632, 5.465913e-02, 4.114260e-03, 1.803946e-01
-7633, -4.102792e-02, 3.607557e-02, 3.173268e-01
-7634, 5.386732e-02, 1.102789e-02, 1.501044e-01
-7635, 5.212855e-02, 1.698614e-02, 1.471906e-01
-7636, 5.220959e-02, 1.678554e-02, 1.529115e-01
-7637, 4.249476e-02, 3.481909e-02, 2.331414e-01
-7638, 4.333205e-02, 3.357788e-02, 1.687051e-01
-7639, 1.525346e-02, 5.279318e-02, 2.482168e-01
-7640, -4.845113e-02, -2.343484e-02, 1.167796e-01
-7641, 5.269866e-02, -1.425040e-02, 1.080305e-01
-7642, 5.232587e-02, -1.622767e-02, 1.134876e-01
-7643, 5.416171e-02, -9.485499e-03, 1.110848e-01
-7644, 3.906022e-02, 3.865664e-02, 4.715303e-01
-7645, 4.081698e-02, 3.686054e-02, 4.625472e-01
-7646, 4.298121e-02, 3.402968e-02, 4.708038e-01
-7647, -2.547854e-02, 4.871778e-02, 1.608114e-01
-7648, 4.699485e-02, 2.837638e-02, 1.471674e-01
-7649, 4.088112e-02, 3.657036e-02, 1.441688e-01
-7650, 5.417684e-02, 9.479719e-03, 2.664927e-01
-7651, 5.418925e-02, 9.407746e-03, 2.608495e-01
-7652, -5.452390e-02, -6.704103e-03, 3.377136e-01
-7653, 5.229138e-02, 1.643076e-03, 4.911156e-01
-7654, 1.212625e-02, -5.331788e-02, 3.371760e-01
-7655, 1.512909e-02, -5.202182e-02, 3.302400e-01
-7656, 2.355354e-02, -4.943444e-02, 3.396163e-01
-7657, 2.655638e-02, -4.813839e-02, 3.326802e-01
-7658, 5.451129e-02, -4.919013e-03, 1.136222e-01
-7659, 5.451129e-02, -4.919013e-03, 1.199548e-01
-7660, 2.623034e-02, 4.809441e-02, 3.649482e-01
-7661, -2.002534e-02, -5.091891e-02, 3.069689e-01
-7662, 3.746735e-02, 4.023020e-02, 4.174399e-01
-7663, -5.450973e-02, 6.893043e-03, 1.330518e-01
-7664, 4.965759e-02, -2.339005e-02, 1.300023e-01
-7665, 4.873587e-02, -2.545256e-02, 1.368719e-01
-7666, 2.609914e-02, -4.841084e-02, 2.581634e-01
-7667, -1.614378e-03, 5.452801e-02, 1.756979e-01
-7668, 6.030613e-03, 5.466559e-02, 4.948201e-01
-7669, 5.500000e-02, -1.347111e-17, 3.497703e-01
-7670, 5.500000e-02, -1.347111e-17, 3.434713e-01
-7671, -5.378933e-02, -1.142110e-02, 4.829105e-01
-7672, -4.975622e-02, 2.318797e-02, 2.816342e-01
-7673, -5.143035e-02, 1.437496e-02, 2.939409e-01
-7674, -5.497668e-02, 1.348814e-03, 2.876514e-01
-7675, 4.344629e-02, 3.349518e-02, 6.078633e-02
-7676, 3.696377e-02, 4.044680e-02, 6.316867e-02
-7677, -2.952631e-04, -5.498824e-02, 4.893813e-01
-7678, 5.717228e-02, -4.077961e-03, 3.221885e-01
-7679, 5.121586e-03, -5.472761e-02, 3.289605e-01
-7680, -9.350438e-03, -5.379647e-02, 3.130835e-01
-7681, 2.733723e-03, -5.474536e-02, 3.178987e-01
-7682, 5.405771e-02, 1.011306e-02, 1.112431e-01
-7683, 8.715397e-03, 5.326644e-02, 3.890626e-01
-7684, 2.094105e-02, 5.085072e-02, 3.883939e-01
-7685, -5.467247e-02, -5.823712e-03, 7.638036e-02
-7686, -1.227397e-02, 5.361274e-02, 4.890864e-01
-7687, -1.725588e-02, 5.198908e-02, 4.888159e-01
-7688, 4.648776e-02, -2.892825e-02, 5.460527e-02
-7689, 5.390768e-02, -1.086518e-02, 7.783015e-02
-7690, 1.105924e-02, -5.332279e-02, 1.170778e-01
-7691, 4.982656e-02, 2.309899e-02, 2.458159e-01
-7692, 4.642652e-02, 2.928094e-02, 2.490597e-01
-7693, -4.427462e-03, 5.478550e-02, 5.913325e-03
-7694, 3.492812e-02, -4.242963e-02, 4.362176e-03
-7695, 2.621561e-02, -4.823145e-02, 4.659443e-03
-7696, 2.174276e-02, -5.050564e-02, 4.659443e-03
-7697, 2.463560e-02, -4.914387e-02, 1.058807e-02
-7698, 5.394029e-02, 1.070349e-02, 1.444538e-01
-7699, 3.736432e-02, 4.028093e-02, 4.358441e-01
-7700, -3.723730e-02, 3.946443e-02, 3.733327e-01
-7701, -4.131437e-02, 3.615796e-02, 3.873041e-01
-7702, 3.011355e-02, -4.532426e-02, 3.858401e-01
-7703, 8.644516e-04, 5.499176e-02, 5.064768e-03
-7704, 5.651353e-02, 8.430234e-03, 4.924682e-01
-7705, 3.693749e-02, -4.047473e-02, 8.595521e-03
-7706, 3.092625e-02, -4.483376e-02, 1.104733e-01
-7707, 4.999601e-02, 2.267142e-02, 2.512672e-01
-7708, 5.088187e-02, 2.084926e-02, 2.578578e-01
-7709, -5.287540e-02, 1.495822e-02, 4.938561e-03
-7710, -5.340514e-02, 1.220749e-02, 1.152024e-02
-7711, -5.224865e-02, 1.717633e-02, 1.046477e-02
-7712, 5.452537e-02, 5.315325e-03, 2.358985e-01
-7713, 5.453280e-02, 5.273882e-03, 2.302926e-01
-7714, 5.500000e-02, -1.347111e-17, 2.274037e-01
-7715, 5.453280e-02, 5.273882e-03, 2.247146e-01
-7716, 5.446975e-02, -5.121647e-03, 2.248385e-01
-7717, 1.287398e-02, -5.271211e-02, 1.558676e-01
-7718, 4.531623e-02, -3.055894e-02, 1.251321e-01
-7719, 5.011000e-02, -2.254209e-02, 1.243902e-01
-7720, 4.842560e-02, -2.605123e-02, 1.179957e-01
-7721, 5.500000e-02, -1.347111e-17, 3.381039e-01
-7722, 5.500000e-02, -1.347111e-17, 3.327364e-01
-7723, 1.450150e-02, 5.303591e-02, 2.102933e-01
-7724, 4.629570e-02, -2.894832e-02, 3.392119e-01
-7725, 4.428973e-02, -3.194953e-02, 3.459419e-01
-7726, -4.183828e-02, 3.531105e-02, 4.112467e-01
-7727, -4.853223e-02, 2.520445e-02, 4.104970e-01
-7728, -4.698739e-02, 2.847053e-02, 4.219088e-01
-7729, 5.500000e-02, -1.347111e-17, 4.717614e-01
-7730, 5.403946e-02, -1.012331e-02, 2.105842e-01
-7731, -7.097841e-03, 5.428983e-02, 3.299656e-01
-7732, 6.937960e-03, 5.401698e-02, 3.360885e-01
-7733, 4.290952e-03, 5.458248e-02, 3.247675e-01
-7734, 3.709486e-02, 4.055311e-02, 4.267573e-01
-7735, 4.355033e-02, 3.322717e-02, 3.719229e-01
-7736, 3.769151e-02, 3.992525e-02, 3.729471e-01
-7737, -4.707546e-02, -2.827065e-02, 3.134139e-01
-7738, -2.314806e-02, -4.972778e-02, 4.154817e-01
-7739, 4.374352e-02, -3.250248e-02, 3.199494e-01
-7740, -4.873508e-02, 2.546276e-02, 4.332638e-01
-7741, 1.034834e-02, 5.288318e-02, 3.828454e-01
-7742, -2.064333e-02, 5.076608e-02, 5.265801e-02
-7743, -4.895754e-02, -2.479619e-02, 2.614904e-01
-7744, -4.821855e-02, -2.595171e-02, 2.744785e-01
-7745, 5.190370e-02, 1.777571e-02, 3.523186e-01
-7746, 4.264078e-02, 3.472782e-02, 1.658554e-02
-7747, -4.980532e-02, -2.277364e-02, 9.728745e-03
-7748, -4.978402e-02, -2.269863e-02, 3.194497e-02
-7749, 5.046158e-02, 2.187662e-02, 5.038179e-03
-7750, -3.825932e-02, -3.916000e-02, 4.476280e-01
-7751, 4.673788e-02, 2.884289e-02, 3.880411e-01
-7752, -4.326989e-03, 5.466549e-02, 2.857155e-01
-7753, -1.362305e-02, -5.255350e-02, 2.106501e-01
-7754, -5.108850e-02, -2.027190e-02, 1.567540e-02
-7755, -2.753253e-02, -4.761186e-02, 6.064186e-03
-7756, 5.003732e-02, 2.255316e-02, 3.904572e-01
-7757, -4.191976e-02, -3.554148e-02, 1.463246e-01
-7758, 5.028233e-02, 2.208682e-02, 3.831307e-01
-7759, -2.340601e-03, -5.486998e-02, 4.832053e-01
-7760, 1.118115e-02, -5.306996e-02, 3.103717e-01
-7761, 6.515799e-04, -5.493370e-02, 3.060327e-01
-7762, 5.243134e-02, -1.562562e-02, 4.137205e-01
-7763, 4.772660e-02, 2.719158e-02, 4.501112e-01
-7764, 4.305980e-02, 3.287909e-02, 4.485591e-01
-7765, 4.407848e-02, 3.260316e-02, 4.569642e-01
-7766, 3.941168e-02, 3.829066e-02, 4.554121e-01
-7767, 5.259317e-02, 1.518358e-02, 2.580678e-01
-7768, 5.400711e-02, -1.039632e-02, 1.000836e-01
-7769, 5.416275e-02, -9.480281e-03, 1.052845e-01
-7770, 5.252649e-02, -1.564726e-02, 1.045603e-01
-7771, 5.251504e-02, -1.568488e-02, 2.886364e-01
-7772, 5.415052e-02, -9.554409e-03, 2.883871e-01
-7773, 2.286142e-02, 4.862577e-02, 2.410081e-01
-7774, 2.154602e-02, 5.056811e-02, 4.538302e-03
-7775, 5.465243e-02, -4.553364e-03, 4.579154e-01
-7776, -1.863459e-02, -5.155662e-02, 3.260025e-02
-7777, -2.029973e-02, -5.105394e-02, 2.456549e-02
-7778, -2.411433e-02, -4.939007e-02, 2.994743e-02
-7779, 2.088562e-03, -5.479067e-02, 1.809145e-02
-7780, -4.028681e-02, 3.470963e-02, 3.615410e-01
-7781, 5.378710e-02, 1.133251e-02, 1.943372e-01
-7782, 3.897535e-02, -3.877663e-02, 1.539180e-01
-7783, 3.504619e-02, 4.209042e-02, 1.648115e-02
-7784, 3.667679e-02, 4.081347e-02, 1.060368e-02
-7785, 2.032082e-02, 5.110788e-02, 4.185452e-01
-7786, 2.917540e-02, 4.569610e-02, 4.131607e-01
-7787, 4.003640e-02, 3.695795e-02, 2.463410e-01
-7788, -5.400673e-02, 9.821749e-03, 5.366674e-03
-7789, -5.477621e-02, 4.810058e-03, 5.366674e-03
-7790, 7.238925e-03, 5.409089e-02, 1.486506e-01
-7791, -3.933116e-02, 3.753866e-02, 4.233784e-01
-7792, -5.491634e-02, 2.241406e-03, 4.702220e-01
-7793, -5.477728e-02, -3.943087e-04, 4.625491e-01
-7794, -5.224102e-02, -1.561312e-02, 2.821100e-01
-7795, -9.767769e-03, 5.404580e-02, 4.948797e-01
-7796, -4.657783e-03, 5.477363e-02, 4.949016e-01
-7797, -7.163989e-03, 5.434057e-02, 4.891083e-01
-7798, 5.396345e-02, 1.058048e-02, 4.447573e-01
-7799, 4.479890e-02, 3.140373e-02, 4.633612e-01
-7800, 4.803784e-02, 2.666109e-02, 5.082218e-02
-7801, 4.072767e-02, 3.667725e-02, 4.779640e-01
-7802, 5.500000e-02, -1.347111e-17, 1.945164e-01
-7803, 5.500000e-02, -1.347111e-17, 2.008378e-01
-7804, 5.453742e-02, -5.247908e-03, 1.973734e-01
-7805, 3.371632e-02, 4.306413e-02, 4.592563e-01
-7806, -3.038090e-02, 4.539088e-02, 1.205719e-01
-7807, -1.775421e-02, 5.127938e-02, 1.180713e-01
-7808, 3.250745e-02, 4.390962e-02, 2.682705e-01
-7809, 5.440981e-02, -5.400095e-03, 3.192319e-01
-7810, -5.449154e-02, -7.326562e-03, 4.612871e-01
-7811, -1.260042e-02, -5.350196e-02, 4.834008e-01
-7812, -7.538979e-03, -5.441106e-02, 4.830252e-01
-7813, -1.040088e-02, -5.400748e-02, 4.890766e-01
-7814, -5.464783e-02, -6.214110e-03, 3.694358e-01
-7815, 4.520554e-02, -3.077378e-02, 1.364558e-01
-7816, 1.359869e-02, 5.327149e-02, 1.487943e-02
-7817, 5.374748e-02, -1.165165e-02, 4.568661e-03
-7818, 3.251233e-02, 4.426809e-02, 2.256500e-02
-7819, 2.709600e-02, 4.776721e-02, 2.243911e-02
-7820, -4.919557e-02, -2.456545e-02, 3.756283e-01
-7821, -6.384546e-03, 5.459880e-02, 1.853312e-01
-7822, -6.856905e-03, 5.452542e-02, 1.984322e-01
-7823, 4.210481e-02, 3.537885e-02, 4.945522e-01
-7824, 5.046490e-02, 2.173092e-02, 5.466373e-02
-7825, -4.222451e-02, -3.450339e-02, 2.537268e-01
-7826, 4.931135e-02, -2.434968e-02, 1.748986e-01
-7827, 4.438135e-02, 3.237216e-02, 1.755216e-01
-7828, 5.095242e-02, -2.064867e-02, 1.239543e-02
-7829, 5.453393e-02, 5.267521e-03, 1.975710e-01
-7830, -5.140682e-02, -1.386768e-02, 2.557021e-01
-7831, 5.155677e-02, -1.788570e-02, 1.185979e-01
-7832, -5.117240e-02, -1.801674e-02, 3.190327e-01
-7833, -4.751542e-02, -2.760913e-02, 3.253527e-01
-7834, -5.061699e-02, -1.849570e-02, 3.330524e-01
-7835, -5.146765e-02, -1.867774e-02, 1.279712e-01
-7836, -4.101480e-02, 3.605282e-02, 1.213478e-01
-7837, -3.609533e-02, 4.149827e-02, 1.330357e-01
-7838, 4.434587e-02, 3.221568e-02, 1.002290e-01
-7839, 5.456063e-02, 5.115554e-03, 2.523242e-01
-7840, 5.456063e-02, 5.115554e-03, 2.470895e-01
-7841, 5.500000e-02, -1.347111e-17, 2.446289e-01
-7842, 5.500000e-02, -1.347111e-17, 2.498636e-01
-7843, 1.131173e-02, 5.360144e-02, 1.820154e-01
-7844, 6.541557e-03, 5.367223e-02, 1.916487e-01
-7845, -3.167275e-02, 4.494219e-02, 6.965758e-02
-7846, -2.838986e-02, 4.685192e-02, 5.750005e-02
-7847, 5.407253e-02, -9.906783e-03, 4.551983e-01
-7848, 5.410318e-02, -9.843523e-03, 4.111287e-01
-7849, 4.237097e-02, 3.493490e-02, 3.664877e-01
-7850, 4.683404e-02, -2.865774e-02, 4.907550e-01
-7851, -5.628493e-03, -5.443622e-02, 1.057723e-02
-7852, 4.356497e-02, -3.356254e-02, 4.834571e-02
-7853, 3.127511e-02, 4.524163e-02, 3.504152e-01
-7854, 5.500000e-02, -1.347111e-17, 3.610525e-01
-7855, 5.411269e-02, 9.837491e-03, 1.998949e-01
-7856, 5.697225e-02, -4.345245e-03, 2.899747e-03
-7857, 5.433673e-02, -8.491569e-03, 6.176822e-03
-7858, 5.213074e-02, -2.940542e-03, 9.076568e-03
-7859, -1.746722e-03, -5.492466e-02, 2.173472e-01
-7860, 4.731762e-02, 2.780118e-02, 6.366627e-02
-7861, 1.594571e-02, -5.250467e-02, 4.728221e-01
-7862, 5.453122e-02, 5.282689e-03, 4.412359e-01
-7863, -3.095885e-02, 4.543947e-02, 1.026439e-02
-7864, -1.294494e-02, 5.316237e-02, 7.655475e-02
-7865, -3.304621e-03, 5.465821e-02, 7.293629e-02
-7866, 5.164627e-02, -1.749864e-02, 3.978540e-01
-7867, -2.923716e-02, -4.646382e-02, 2.895616e-02
-7868, 2.567960e-02, 4.793191e-02, 2.512681e-01
-7869, 1.895990e-02, 5.161308e-02, 2.594595e-01
-7870, 9.208446e-03, 5.384983e-02, 6.850535e-02
-7871, 1.851249e-02, 5.130968e-02, 2.777157e-01
-7872, 5.424395e-02, -9.054195e-03, 4.662463e-01
-7873, 5.459151e-02, -4.500832e-03, 4.692458e-01
-7874, 5.500000e-02, -1.347111e-17, 1.282053e-01
-7875, 5.500000e-02, -1.347111e-17, 1.232221e-01
-7876, -2.405132e-02, 4.942926e-02, 4.945142e-03
-7877, -2.645483e-02, 4.802307e-02, 1.020850e-02
-7878, 5.688055e-02, -6.463829e-03, 2.883418e-01
-7879, 5.189147e-02, 1.780503e-02, 3.466686e-01
-7880, 2.915053e-02, 4.562037e-02, 3.933116e-01
-7881, -2.940877e-02, 4.647190e-02, 5.263360e-03
-7882, 3.776992e-02, 3.949836e-02, 1.752821e-01
-7883, 1.670026e-02, -5.225623e-02, 4.253660e-01
-7884, -4.182546e-02, -3.566040e-02, 1.618279e-01
-7885, -1.784707e-02, -5.199813e-02, 4.946870e-01
-7886, 2.411869e-03, 5.353159e-02, 2.040411e-01
-7887, 5.464145e-02, -4.624314e-03, 2.856448e-01
-7888, 5.500000e-02, -1.347111e-17, 3.164434e-01
-7889, -1.249108e-02, -5.263607e-02, 4.263404e-01
-7890, -3.570674e-03, -5.486210e-02, 4.332233e-01
-7891, 3.300029e-02, -4.338627e-02, 2.646092e-01
-7892, -9.773735e-03, -5.386021e-02, 4.426252e-01
-7893, 9.229239e-03, 5.384396e-02, 8.202444e-02
-7894, -2.523970e-02, 4.886551e-02, 1.274068e-01
-7895, 5.456972e-02, 5.062794e-03, 2.578736e-01
-7896, -1.033215e-02, -5.258552e-02, 1.977065e-01
-7897, -5.297018e-02, 1.382053e-02, 1.230590e-01
-7898, -5.021194e-02, 1.910977e-02, 1.128914e-01
-7899, -3.402634e-02, 4.315776e-02, 1.452967e-02
-7900, 5.456972e-02, 5.062794e-03, 2.632411e-01
-7901, 5.451364e-02, 5.380039e-03, 1.525541e-01
-7902, -5.300013e-02, 1.104528e-02, 3.158412e-01
-7903, 2.315426e-02, 4.974651e-02, 2.680693e-01
-7904, -3.733425e-02, 3.942008e-02, 3.017465e-01
-7905, 5.229941e-02, 1.650729e-02, 1.194331e-01
-7906, 4.684459e-02, 2.863383e-02, 2.953095e-01
-7907, 5.012407e-02, 2.241907e-02, 2.927236e-01
-7908, -4.071394e-02, 3.344289e-02, 2.740277e-01
-7909, -5.345051e-02, 1.246422e-02, 4.338304e-01
-7910, 5.231756e-02, 1.659013e-02, 3.019850e-01
-7911, 5.229013e-02, 1.666141e-02, 3.076384e-01
-7912, 5.242438e-02, -1.611258e-02, 4.540247e-01
-7913, 5.242668e-02, 1.611663e-02, 2.962915e-01
-7914, -5.276970e-02, -1.541587e-02, 1.702672e-02
-7915, -2.015869e-02, 5.114172e-02, 4.688701e-01
-7916, -2.259606e-02, 4.996411e-02, 4.757738e-01
-7917, -1.772149e-02, 5.206327e-02, 4.760974e-01
-7918, -5.242624e-02, 1.661356e-02, 4.899706e-01
-7919, 5.455729e-02, 5.134858e-03, 3.912619e-01
-7920, 5.455729e-02, 5.134858e-03, 3.970407e-01
-7921, 5.171866e-02, -1.748058e-02, 1.526307e-01
-7922, 5.040884e-02, -2.175497e-02, 1.817105e-01
-7923, 4.278816e-02, -3.341565e-02, 3.531120e-01
-7924, -3.207635e-02, -4.290429e-02, 1.162105e-01
-7925, 5.227245e-02, -1.641806e-02, 4.568661e-03
-7926, 5.052527e-02, -2.172797e-02, 5.048662e-03
-7927, -2.546607e-02, 4.852028e-02, 4.688046e-01
-7928, -3.050467e-02, 4.576229e-02, 4.685914e-01
-7929, 2.115981e-02, 5.076360e-02, 3.788966e-01
-7930, 1.107362e-02, 5.293548e-02, 2.682448e-01
-7931, 5.174319e-02, -1.774085e-02, 4.465270e-01
-7932, 2.877779e-02, 4.544748e-02, 2.603725e-01
-7933, 3.549749e-02, 4.176631e-02, 2.521810e-01
-7934, -3.790605e-02, -3.785164e-02, 3.551428e-01
-7935, -3.033507e-02, -4.587627e-02, 3.610699e-01
-7936, 4.857279e-02, 2.529261e-02, 3.459114e-01
-7937, 5.394273e-02, -1.054824e-02, 1.997198e-01
-7938, -4.289235e-02, -3.377543e-02, 3.644820e-01
-7939, -3.188136e-02, -4.432191e-02, 2.599469e-01
-7940, -3.856257e-03, 5.473253e-02, 2.679787e-01
-7941, 6.158758e-03, 5.438925e-02, 2.776665e-01
-7942, -3.095413e-02, 4.497291e-02, 1.398706e-01
-7943, 4.030020e-03, 5.341013e-02, 2.591934e-01
-7944, -3.081145e-02, -4.425835e-02, 1.692318e-01
-7945, -3.971745e-02, -3.769041e-02, 1.734753e-01
-7946, -1.421784e-02, 5.305438e-02, 5.397653e-03
-7947, -1.499133e-02, -5.240947e-02, 2.200815e-01
-7948, -3.580877e-03, -5.485026e-02, 1.812736e-02
-7949, -1.775849e-02, -5.203109e-02, 6.038656e-03
-7950, -1.312722e-02, -5.333460e-02, 4.951945e-03
-7951, -1.554898e-02, -5.260088e-02, 1.165329e-02
-7952, -1.529172e-02, -5.263791e-02, 4.891066e-01
-7953, 5.432168e-02, -6.343427e-03, 1.644256e-01
-7954, 5.219262e-02, -1.681304e-02, 1.332032e-01
-7955, -2.047317e-02, -5.088366e-02, 2.798047e-01
-7956, 5.399164e-02, 1.043020e-02, 1.222538e-01
-7957, 4.988785e-02, -2.312256e-02, 9.533689e-02
-7958, 4.254765e-02, -3.476078e-02, 5.659901e-02
-7959, -4.857260e-02, 2.556941e-02, 6.073493e-02
-7960, 4.495183e-02, 3.165115e-02, 3.423665e-01
-7961, -3.160283e-02, -4.501399e-02, 4.839745e-01
-7962, -1.265376e-02, 5.318527e-02, 2.765006e-01
-7963, 1.886372e-02, 5.166177e-02, 4.708402e-01
-7964, 5.229046e-02, 1.647171e-02, 6.942829e-02
-7965, -1.207612e-02, 5.334968e-02, 4.770103e-01
-7966, 5.007306e-02, 2.260060e-02, 1.499954e-01
-7967, -9.752308e-03, 5.408424e-02, 4.835119e-01
-7968, -1.488617e-02, 5.288180e-02, 4.830408e-01
-7969, 4.883878e-02, -2.528543e-02, 3.157191e-01
-7970, 4.735390e-02, 2.772746e-02, 5.718900e-02
-7971, 2.861277e-02, 4.564198e-02, 4.228244e-01
-7972, 3.082138e-02, -4.548418e-02, 4.362176e-03
-7973, 2.467795e-02, 4.898177e-02, 4.725721e-01
-7974, -1.390634e-02, -5.295175e-02, 4.633910e-01
-7975, -2.087499e-02, -5.081072e-02, 4.641135e-01
-7976, 5.004250e-02, 2.253958e-02, 3.961345e-01
-7977, 5.260377e-02, -1.467723e-02, 4.083357e-01
-7978, 4.209536e-02, -3.537944e-02, 4.780732e-03
-7979, 4.359986e-02, -3.335059e-02, 9.980485e-03
-7980, 3.916275e-02, -3.858630e-02, 4.233345e-03
-7981, -3.572914e-02, -4.137140e-02, 4.853171e-02
-7982, -4.347448e-02, -3.273470e-02, 3.772513e-01
-7983, 3.170524e-02, -4.429569e-02, 4.162626e-01
-7984, 1.401641e-02, 5.313800e-02, 4.894118e-01
-7985, -5.144882e-02, 1.929024e-02, 4.948446e-01
-7986, 3.907997e-02, -3.868362e-02, 4.846926e-01
-7987, 2.068887e-03, -5.495084e-02, 4.945997e-01
-7988, 5.452537e-02, 5.315325e-03, 2.417221e-01
-7989, 5.500000e-02, -1.347111e-17, 1.497656e-01
-7990, 5.500000e-02, -1.347111e-17, 1.442100e-01
-7991, 1.985874e-02, -5.120016e-02, 1.115139e-02
-7992, 1.489753e-02, -5.287432e-02, 1.197611e-02
-7993, 5.086612e-02, -1.955522e-02, 2.716385e-01
-7994, 5.464145e-02, -4.624314e-03, 2.806616e-01
-7995, 5.500000e-02, -1.347111e-17, 3.826800e-01
-7996, 5.414683e-04, 5.499249e-02, 4.944178e-01
-7997, -5.545126e-04, 5.495625e-02, 4.658534e-01
-7998, 4.864479e-03, 5.471106e-02, 4.644070e-01
-7999, -4.135925e-04, 5.496231e-02, 4.573413e-01
-8000, -2.880324e-02, -4.656838e-02, 3.274430e-01
-8001, 5.500000e-02, -1.347111e-17, 2.755130e-02
-8002, 4.653627e-02, 2.867704e-02, 1.294209e-01
-8003, 5.461560e-02, -4.787084e-03, 2.026717e-01
-8004, 5.234605e-02, 1.630280e-02, 2.189770e-01
-8005, -1.669164e-02, 5.209429e-02, 4.613364e-01
-8006, 5.500000e-02, -1.347111e-17, 2.834368e-01
-8007, 5.458097e-02, 4.996631e-03, 4.025281e-01
-8008, 2.918036e-02, 4.586341e-02, 4.322270e-01
-8009, 2.162773e-02, -5.051655e-02, 1.265434e-01
-8010, 5.442878e-02, -5.826415e-03, 3.303521e-01
-8011, 5.387995e-02, -1.103605e-02, 3.330235e-01
-8012, -4.407498e-02, -3.158883e-02, 2.400484e-01
-8013, 5.404494e-02, -1.005295e-02, 2.830175e-01
-8014, 4.142112e-02, 3.604092e-02, 1.354857e-01
-8015, 5.104522e-02, -2.046009e-02, 2.914812e-01
-8016, 5.247977e-02, -1.547208e-02, 2.964464e-01
-8017, -4.109955e-02, 3.364822e-02, 2.626996e-01
-8018, 2.374935e-02, -4.960765e-02, 1.173480e-01
-8019, -4.365131e-03, 5.469745e-02, 4.837230e-01
-8020, 5.255557e-02, -1.578817e-02, 1.786712e-01
-8021, 1.650578e-03, -5.496535e-02, 1.850675e-01
-8022, -5.493641e-03, -5.452931e-02, 4.892012e-01
-8023, 5.189864e-02, -1.721992e-02, 4.060483e-01
-8024, -3.146534e-02, 4.488389e-02, 2.377876e-02
-8025, 7.407274e-04, -5.493714e-02, 2.949947e-01
-8026, -2.540912e-02, -4.864086e-02, 2.390953e-02
-8027, 1.141291e-02, 5.380230e-02, 4.946695e-01
-8028, 5.423048e-02, 9.161799e-03, 3.292856e-02
-8029, 5.454962e-02, -5.178804e-03, 4.235437e-02
-8030, 5.269961e-02, -1.533876e-02, 1.191543e-02
-8031, -2.392621e-02, 4.885635e-02, 6.481554e-02
-8032, 4.527461e-02, -3.058784e-02, 4.286057e-01
-8033, 5.131204e-02, -1.869391e-02, 1.456897e-01
-8034, 2.875989e-02, 4.606424e-02, 3.738460e-01
-8035, -3.576081e-02, 4.177967e-02, 4.432383e-01
-8036, 5.465042e-02, -4.566486e-03, 1.080195e-01
-8037, 2.266152e-02, -5.006389e-02, 1.853796e-01
-8038, 4.242293e-02, 3.473347e-02, 4.328771e-01
-8039, 4.620309e-02, 2.981792e-02, 1.589407e-02
-8040, 5.451364e-02, 5.380039e-03, 1.469986e-01
-8041, 5.500000e-02, -1.347111e-17, 4.051174e-01
-8042, -1.029284e-02, -5.350679e-02, 2.993345e-01
-8043, -3.011071e-02, 4.600458e-02, 2.066506e-01
-8044, -1.794914e-02, 5.089482e-02, 2.004919e-01
-8045, -3.052774e-02, 4.518436e-02, 1.500280e-01
-8046, 3.943204e-02, 3.790074e-02, 2.862960e-02
-8047, 4.508453e-02, -3.149124e-02, 1.683675e-02
-8048, -5.376358e-02, -1.213572e-02, 4.111328e-01
-8049, 1.186055e-02, 5.370564e-02, 4.834238e-01
-8050, -4.554125e-02, 2.882763e-02, 3.994053e-01
-8051, -5.498641e-02, -1.219960e-03, 4.949347e-01
-8052, 3.328756e-02, 4.376450e-02, 2.440594e-01
-8053, -4.004168e-02, 3.486689e-02, 3.445505e-01
-8054, -2.252250e-02, -4.994966e-02, 4.720310e-01
-8055, 5.500000e-02, -1.347111e-17, 7.212742e-02
-8056, 4.682777e-02, 2.855826e-02, 3.192535e-01
-8057, -4.255376e-02, 3.449196e-02, 4.515815e-01
-8058, 3.079766e-02, 4.546283e-02, 4.707247e-03
-8059, -3.850690e-02, -3.823865e-02, 3.192499e-01
-8060, -4.360631e-02, 3.283611e-02, 4.624410e-01
-8061, 4.406704e-02, 3.271597e-02, 2.104145e-01
-8062, 4.769558e-02, 2.721375e-02, 3.672678e-01
-8063, -7.072121e-04, 5.484315e-02, 4.022342e-02
-8064, 5.500000e-02, -1.347111e-17, 1.168895e-01
-8065, 1.465214e-02, -5.181718e-02, 1.796123e-01
-8066, -1.296419e-02, -5.340135e-02, 4.944196e-01
-8067, 5.452741e-02, -5.303957e-03, 4.791428e-02
-8068, 5.453072e-02, 5.285496e-03, 7.484676e-02
-8069, -2.942777e-02, 4.645956e-02, 4.945466e-01
-8070, -2.316708e-02, -4.988002e-02, 5.171522e-03
-8071, 2.751511e-02, -4.761198e-02, 2.699173e-01
-8072, 4.836423e-02, -2.618382e-02, 4.951979e-01
-*ELEMENT, ELSET=Eall,TYPE=C3D10
-2969, 961, 339, 960, 805, 5495, 5494, 2296, 2294, 5496, 2292,
-2970, 404, 910, 985, 984, 5498, 2363, 5497, 5499, 2360, 2364,
-2971, 353, 875, 1031, 876, 5501, 2497, 5500, 5502, 1999, 2498,
-2972, 355, 1036, 1035, 487, 5504, 2514, 5503, 4471, 5506, 5505,
-2973, 1024, 349, 1023, 868, 5508, 5507, 2478, 2476, 5509, 2474,
-2974, 581, 1212, 1177, 1279, 5511, 3134, 5510, 5512, 3416, 3415,
-2975, 511, 1113, 1116, 1181, 5514, 2944, 5513, 5515, 3014, 3013,
-2976, 990, 415, 1111, 1061, 5517, 5516, 2778, 2600, 5518, 2777,
-2977, 307, 1005, 858, 857, 5520, 2567, 5519, 5521, 2422, 1945,
-2978, 804, 959, 375, 960, 2289, 5523, 5522, 2291, 2293, 5524,
-2979, 1094, 1217, 615, 596, 3158, 5526, 5525, 5527, 5528, 5033,
-2980, 1090, 959, 375, 494, 2714, 5523, 5529, 5530, 5531, 4743,
-2981, 1117, 1016, 452, 1015, 2802, 5533, 5532, 2801, 2454, 5534,
-2982, 72, 918, 216, 217, 5536, 2109, 5535, 5537, 2108, 1453,
-2983, 1285, 645, 647, 1261, 5539, 5001, 5538, 3435, 5541, 5540,
-2984, 1106, 1223, 513, 1104, 3186, 5543, 5542, 2926, 3187, 5544,
-2985, 307, 1005, 857, 839, 5520, 2422, 5521, 5545, 2421, 2225,
-2986, 413, 832, 914, 267, 5547, 2201, 5546, 4236, 5549, 5548,
-2987, 260, 911, 202, 203, 5551, 2095, 5550, 5552, 2094, 1439,
-2988, 1208, 1207, 616, 1274, 3110, 5554, 5553, 3398, 3395, 5555,
-2989, 746, 1236, 747, 1273, 5557, 5556, 5342, 5558, 3392, 5559,
-2990, 1277, 674, 671, 1260, 5561, 5147, 5560, 3405, 5563, 5562,
-2991, 297, 931, 441, 296, 5565, 5564, 4321, 3886, 5566, 4320,
-2992, 900, 238, 239, 36, 5568, 3712, 5567, 5569, 3708, 3710,
-2993, 1237, 641, 678, 642, 5571, 5112, 5570, 5572, 4985, 5113,
-2994, 297, 931, 296, 128, 5565, 5566, 3886, 5573, 2139, 5574,
-2995, 10, 149, 9, 225, 3553, 3550, 1502, 3678, 5575, 3679,
-2996, 590, 1181, 624, 511, 5577, 5576, 5058, 4821, 5515, 4929,
-2997, 989, 266, 265, 412, 5579, 3793, 5578, 5580, 4233, 4232,
-2998, 914, 266, 64, 63, 5582, 3792, 5581, 5583, 3791, 1587,
-2999, 570, 368, 1078, 477, 4742, 5585, 5584, 4741, 4432, 5586,
-3000, 43, 348, 44, 866, 4009, 4008, 1567, 5587, 5589, 5588,
-3001, 1260, 674, 671, 629, 5563, 5147, 5562, 5590, 5146, 5091,
-3002, 517, 987, 1101, 1060, 5592, 2750, 5591, 5593, 2647, 2751,
-3003, 880, 881, 319, 58, 2014, 5595, 5594, 5596, 5597, 3939,
-3004, 1144, 576, 1145, 1234, 5599, 5598, 2886, 3239, 5600, 3240,
-3005, 339, 961, 960, 376, 5495, 2296, 5494, 4132, 5602, 5601,
-3006, 144, 781, 143, 5, 1751, 1750, 1379, 3541, 5603, 3542,
-3007, 230, 480, 954, 953, 4444, 5605, 5604, 5606, 5607, 2275,
-3008, 1227, 530, 567, 586, 5609, 4765, 5608, 5610, 4807, 4806,
-3009, 329, 425, 814, 236, 4273, 5612, 5611, 4043, 4439, 5613,
-3010, 804, 339, 232, 24, 5615, 4052, 5614, 5616, 3984, 3692,
-3011, 1209, 610, 1275, 1208, 5618, 5617, 3400, 3117, 5619, 3399,
-3012, 954, 480, 373, 1085, 5605, 4467, 5620, 2699, 5622, 5621,
-3013, 956, 1086, 955, 481, 2703, 2702, 2281, 5623, 5625, 5624,
-3014, 1097, 424, 920, 994, 5627, 5626, 2784, 2785, 5628, 2390,
-3015, 1045, 1146, 471, 1147, 2888, 5630, 5629, 2890, 2892, 5631,
-3016, 1023, 1022, 460, 1124, 2475, 5633, 5632, 2822, 2821, 5634,
-3017, 364, 1053, 327, 475, 5636, 5635, 4074, 4424, 5637, 4425,
-3018, 568, 1095, 965, 1094, 5639, 2732, 5638, 5640, 2734, 2730,
-3019, 864, 310, 1019, 863, 5642, 5641, 2462, 1963, 5643, 2461,
-3020, 563, 940, 1073, 1074, 5645, 2657, 5644, 5646, 2658, 2660,
-3021, 584, 1096, 967, 1095, 5648, 2737, 5647, 5649, 2739, 2735,
-3022, 166, 803, 232, 804, 1816, 5651, 5650, 1818, 1820, 5614,
-3023, 29, 28, 341, 172, 1521, 3988, 3987, 3595, 3592, 5652,
-3024, 1155, 535, 1064, 1157, 5654, 5653, 2995, 2996, 5655, 2994,
-3025, 1197, 530, 1227, 586, 5656, 5609, 3069, 5657, 4807, 5610,
-3026, 1179, 1102, 510, 1113, 3007, 5659, 5658, 3006, 2925, 5660,
-3027, 584, 528, 529, 1096, 4843, 4616, 5044, 5648, 5662, 5661,
-3028, 548, 1009, 448, 1071, 5664, 5663, 4674, 5665, 2636, 5666,
-3029, 147, 784, 331, 785, 1759, 5668, 5667, 1761, 1763, 5669,
-3030, 697, 723, 1316, 1323, 5320, 5671, 5670, 5672, 5673, 3476,
-3031, 216, 893, 71, 894, 2049, 5675, 5674, 2051, 2053, 5676,
-3032, 242, 388, 974, 389, 4161, 5678, 5677, 4163, 4165, 5679,
-3033, 1184, 1183, 601, 499, 3100, 5681, 5680, 5682, 5683, 4857,
-3034, 724, 695, 1308, 1311, 5360, 5685, 5684, 5686, 5687, 3524,
-3035, 206, 60, 830, 263, 5689, 5688, 1885, 5690, 3782, 5691,
-3036, 153, 13, 791, 790, 3558, 5692, 1779, 1777, 5693, 1781,
-3037, 921, 281, 999, 840, 5695, 5694, 2404, 2118, 5696, 2403,
-3038, 1023, 457, 460, 312, 5697, 4384, 5632, 5698, 4372, 4382,
-3039, 331, 224, 478, 784, 4044, 4436, 4435, 5668, 5700, 5699,
-3040, 383, 943, 944, 788, 5702, 2245, 5701, 5703, 2241, 2243,
-3041, 540, 541, 1166, 1003, 4653, 5705, 5704, 5706, 5707, 2954,
-3042, 529, 1159, 528, 423, 5709, 5708, 4616, 4614, 5710, 4612,
-3043, 528, 1159, 529, 1096, 5708, 5709, 4616, 5662, 3005, 5661,
-3044, 284, 841, 428, 283, 5712, 5711, 4282, 3847, 5713, 4281,
-3045, 923, 998, 429, 996, 2400, 5715, 5714, 2393, 2401, 5716,
-3046, 996, 533, 429, 532, 5717, 4625, 5716, 5718, 4627, 4623,
-3047, 526, 1190, 1108, 1162, 5720, 3043, 5719, 5721, 3042, 2948,
-3048, 1097, 1159, 529, 423, 2942, 5709, 5722, 5723, 5710, 4614,
-3049, 447, 853, 1009, 1070, 5725, 2431, 5724, 5726, 2632, 2651,
-3050, 1169, 1250, 642, 1167, 3293, 5728, 5727, 3020, 3294, 5729,
-3051, 1165, 1070, 547, 1009, 2952, 5731, 5730, 2951, 2651, 5732,
-3052, 804, 24, 166, 167, 5616, 3584, 1818, 1819, 3583, 1402,
-3053, 1167, 445, 546, 1069, 5734, 4667, 5733, 2957, 5736, 5735,
-3054, 1102, 982, 400, 1113, 2752, 5738, 5737, 2925, 2788, 5739,
-3055, 529, 1159, 1097, 1096, 5709, 2942, 5722, 5661, 3005, 2742,
-3056, 298, 443, 932, 299, 4326, 5741, 5740, 3892, 4327, 5742,
-3057, 945, 368, 1077, 944, 5744, 5743, 2670, 2248, 5745, 2669,
-3058, 1022, 460, 1123, 455, 5633, 5746, 2819, 5747, 4459, 5748,
-3059, 33, 178, 815, 816, 3603, 1852, 5749, 5750, 1854, 1857,
-3060, 186, 820, 903, 41, 1865, 2158, 2079, 5751, 5753, 5752,
-3061, 1112, 1236, 706, 705, 3250, 5755, 5754, 5756, 5757, 5201,
-3062, 399, 981, 253, 982, 5759, 5758, 4194, 5760, 2589, 5761,
-3063, 1274, 666, 616, 610, 5762, 5080, 5555, 5763, 5079, 4909,
-3064, 429, 923, 428, 284, 5714, 5764, 4286, 4284, 5765, 4282,
-3065, 444, 851, 933, 1008, 5767, 2186, 5766, 5768, 2629, 2429,
-3066, 476, 1081, 949, 948, 5770, 2682, 5769, 5771, 2681, 2260,
-3067, 478, 940, 331, 784, 5773, 5772, 4435, 5699, 2231, 5668,
-3068, 1307, 698, 658, 1272, 5775, 5273, 5774, 3366, 5777, 5776,
-3069, 188, 42, 43, 865, 5779, 1566, 5778, 1965, 5781, 5780,
-3070, 1131, 1030, 462, 1029, 2843, 5783, 5782, 2842, 2496, 5784,
-3071, 656, 1247, 1266, 1191, 5786, 3375, 5785, 5787, 3305, 3372,
-3072, 452, 569, 1154, 456, 4740, 5789, 5788, 4370, 4737, 5790,
-3073, 42, 347, 865, 864, 4006, 5791, 5781, 5792, 5793, 1966,
-3074, 1097, 424, 529, 379, 5627, 4615, 5722, 5794, 4617, 4727,
-3075, 1132, 1031, 463, 1030, 2846, 5796, 5795, 2845, 2499, 5797,
-3076, 636, 706, 1192, 707, 5203, 5799, 5798, 5204, 5206, 5800,
-3077, 308, 37, 859, 860, 3916, 5802, 5801, 5803, 5804, 1951,
-3078, 462, 316, 352, 1030, 4391, 4086, 4389, 5783, 5806, 5805,
-3079, 463, 316, 462, 1030, 4393, 4391, 4478, 5797, 5806, 5783,
-3080, 449, 1010, 548, 1071, 5808, 5807, 4847, 5809, 2637, 5665,
-3081, 529, 379, 485, 968, 4727, 4497, 4750, 5810, 5812, 5811,
-3082, 517, 1060, 408, 409, 5593, 5813, 4575, 4576, 5814, 4225,
-3083, 1002, 433, 1066, 926, 5816, 5815, 2619, 2412, 5817, 2618,
-3084, 889, 66, 359, 888, 5819, 4030, 5818, 2038, 5821, 5820,
-3085, 237, 179, 35, 817, 5823, 5822, 3706, 5824, 1860, 5825,
-3086, 987, 518, 1101, 1160, 5827, 5826, 2750, 2935, 5828, 2959,
-3087, 1281, 1214, 653, 1213, 3423, 5830, 5829, 3420, 3145, 5831,
-3088, 850, 298, 96, 297, 5833, 3887, 5832, 5834, 3889, 3885,
-3089, 452, 1015, 1016, 344, 5534, 2454, 5533, 4354, 5836, 5835,
-3090, 1002, 536, 432, 1064, 5838, 4634, 5837, 2614, 5840, 5839,
-3091, 1154, 1117, 452, 1015, 2913, 5532, 5788, 2912, 2801, 5534,
-3092, 897, 898, 364, 75, 2065, 5842, 5841, 5843, 5844, 4041,
-3093, 76, 898, 328, 899, 5846, 5845, 3957, 5847, 2068, 5848,
-3094, 328, 223, 1013, 454, 4042, 5850, 5849, 4434, 4363, 5851,
-3095, 1265, 1173, 746, 1236, 3369, 5853, 5852, 3371, 3251, 5557,
-3096, 782, 223, 330, 454, 5855, 3999, 5854, 5856, 4363, 4362,
-3097, 1055, 413, 414, 832, 5858, 4240, 5857, 2573, 5547, 5859,
-3098, 502, 391, 503, 1114, 4528, 4530, 4532, 5860, 5862, 5861,
-3099, 638, 1246, 1166, 1099, 5864, 3330, 5863, 5865, 3300, 2956,
-3100, 715, 1303, 682, 1332, 5867, 5866, 5285, 5868, 1737, 5869,
-3101, 801, 800, 231, 481, 1811, 5871, 5870, 5872, 5873, 4446,
-3102, 287, 431, 925, 432, 4291, 5875, 5874, 4293, 4295, 5876,
-3103, 331, 784, 8, 224, 5668, 5877, 3967, 4044, 5700, 3676,
-3104, 1166, 1246, 637, 1170, 3330, 5879, 5878, 2977, 3306, 5880,
-3105, 286, 843, 430, 924, 5882, 5881, 4288, 5883, 2207, 5884,
-3106, 987, 1060, 409, 830, 2647, 5814, 5885, 2370, 2596, 5886,
-3107, 942, 787, 943, 366, 2238, 2240, 2242, 5887, 5889, 5888,
-3108, 943, 575, 1076, 1075, 5891, 5890, 2666, 2664, 5892, 2668,
-3109, 920, 424, 425, 278, 5626, 4274, 5893, 5894, 4269, 4271,
-3110, 969, 1097, 424, 970, 2741, 5627, 5895, 2323, 2917, 5896,
-3111, 547, 447, 548, 1009, 4671, 4673, 4675, 5732, 5724, 5664,
-3112, 921, 1005, 999, 365, 2423, 2610, 2404, 5897, 5899, 5898,
-3113, 383, 575, 943, 366, 4759, 5891, 5702, 4148, 4760, 5888,
-3114, 186, 40, 185, 820, 5901, 5900, 1422, 1865, 5902, 1866,
-3115, 179, 237, 35, 34, 5823, 3706, 5822, 5903, 3705, 1558,
-3116, 383, 575, 1076, 943, 4759, 5890, 5904, 5702, 5891, 2666,
-3117, 1274, 1207, 616, 585, 3395, 5554, 5555, 5905, 5906, 5032,
-3118, 1178, 565, 649, 611, 5908, 5012, 5907, 5909, 4894, 5013,
-3119, 535, 432, 1063, 431, 4632, 5911, 5910, 4631, 4295, 5912,
-3120, 262, 830, 263, 409, 5913, 5691, 3784, 4223, 5886, 4224,
-3121, 373, 1085, 955, 954, 5621, 2700, 5914, 5620, 2699, 2278,
-3122, 968, 379, 342, 813, 5812, 4138, 5915, 2316, 5917, 5916,
-3123, 418, 1110, 991, 992, 5919, 2774, 5918, 5920, 2773, 2602,
-3124, 987, 830, 409, 410, 2370, 5886, 5885, 5921, 5922, 4228,
-3125, 184, 38, 183, 819, 5924, 5923, 1420, 1863, 5925, 1864,
-3126, 1112, 705, 706, 635, 5756, 5201, 5754, 5926, 5200, 5202,
-3127, 697, 1323, 735, 729, 5672, 5927, 5398, 5386, 5928, 5315,
-3128, 8, 784, 331, 147, 5877, 5668, 3967, 3547, 1759, 5667,
-3129, 603, 1074, 1075, 563, 5930, 2665, 5929, 4865, 5646, 5931,
-3130, 1057, 1187, 514, 1106, 3030, 5933, 5932, 2765, 3031, 5934,
-3131, 417, 1110, 418, 524, 5935, 5919, 4252, 4598, 5936, 4599,
-3132, 1255, 1273, 747, 1192, 3394, 5559, 5937, 3335, 3391, 5938,
-3133, 327, 1052, 363, 475, 5940, 5939, 4097, 4425, 5941, 4494,
-3134, 451, 578, 582, 1120, 4777, 4779, 4767, 5942, 5944, 5943,
-3135, 463, 1032, 1133, 489, 5946, 2849, 5945, 4480, 5948, 5947,
-3136, 384, 1019, 1121, 1020, 5950, 2812, 5949, 5951, 2466, 2813,
-3137, 451, 578, 1119, 380, 4777, 5953, 5952, 4352, 4778, 5954,
-3138, 1206, 574, 1189, 1161, 5956, 5955, 3104, 3101, 5957, 3038,
-3139, 1133, 1032, 1134, 489, 2849, 2851, 2853, 5947, 5948, 5958,
-3140, 16, 794, 228, 335, 5960, 5959, 3684, 3976, 5961, 4048,
-3141, 1276, 1275, 1210, 717, 3520, 3401, 3404, 5962, 5964, 5963,
-3142, 955, 799, 800, 337, 2276, 1808, 2277, 5965, 5967, 5966,
-3143, 1340, 763, 726, 745, 5969, 5406, 5968, 5970, 5408, 5338,
-3144, 782, 783, 330, 145, 1757, 5971, 5854, 1753, 1755, 5972,
-3145, 1132, 555, 463, 564, 5973, 4690, 5795, 5974, 4719, 4718,
-3146, 257, 910, 404, 827, 5975, 5498, 4208, 5976, 2165, 5977,
-3147, 736, 1326, 1360, 759, 5979, 1707, 5978, 5446, 5981, 5980,
-3148, 1098, 996, 1189, 532, 2744, 2973, 2972, 5982, 5718, 5983,
-3149, 910, 827, 257, 200, 2165, 5976, 5975, 2093, 1879, 5984,
-3150, 694, 724, 702, 1311, 5264, 5263, 5190, 5985, 5686, 5986,
-3151, 675, 1302, 1321, 1324, 5988, 3521, 5987, 5989, 3522, 1738,
-3152, 16, 156, 228, 794, 3566, 5990, 3684, 5960, 1788, 5959,
-3153, 401, 982, 826, 1059, 5992, 2357, 5991, 5993, 2591, 2590,
-3154, 1276, 717, 1210, 607, 5962, 5963, 3404, 5994, 5231, 5995,
-3155, 315, 488, 1029, 1028, 4474, 5997, 5996, 5998, 5999, 2493,
-3156, 374, 482, 958, 494, 4500, 6001, 6000, 4509, 4508, 6002,
-3157, 1334, 1312, 702, 1319, 3378, 6004, 6003, 1712, 3377, 6005,
-3158, 559, 1140, 1232, 1141, 6007, 3082, 6006, 6008, 2874, 3230,
-3159, 1264, 498, 1197, 608, 6010, 6009, 3363, 6011, 4884, 6012,
-3160, 1142, 1041, 1143, 469, 2876, 2878, 2880, 6013, 6015, 6014,
-3161, 1107, 508, 507, 622, 6017, 4548, 6016, 6018, 4819, 4923,
-3162, 990, 1055, 1111, 414, 2575, 2779, 2778, 6019, 5857, 6020,
-3163, 1141, 559, 1201, 1232, 6008, 6021, 3234, 3230, 6006, 3235,
-3164, 1163, 389, 974, 500, 6022, 5679, 2960, 6023, 4522, 6024,
-3165, 129, 931, 297, 128, 2138, 5565, 6025, 1482, 2139, 5573,
-3166, 276, 73, 74, 919, 3821, 1597, 3822, 6026, 6028, 6027,
-3167, 1143, 1041, 1042, 469, 2878, 2532, 2879, 6014, 6015, 6029,
-3168, 788, 226, 383, 332, 6030, 4146, 5703, 6031, 3970, 4147,
-3169, 1163, 389, 501, 390, 6022, 4524, 6032, 6033, 4168, 4525,
-3170, 1188, 1269, 1254, 587, 3380, 3390, 3332, 6034, 6036, 6035,
-3171, 967, 235, 966, 811, 6038, 6037, 2314, 2312, 6039, 2310,
-3172, 639, 1246, 638, 1099, 6040, 5864, 4975, 6041, 3300, 5865,
-3173, 1149, 1148, 560, 1235, 2898, 6043, 6042, 3245, 3243, 6044,
-3174, 974, 388, 500, 389, 5678, 4521, 6024, 5679, 4165, 4522,
-3175, 77, 223, 781, 328, 3958, 6046, 6045, 3956, 4042, 6047,
-3176, 638, 637, 1166, 1246, 4972, 5878, 5863, 5864, 5879, 3330,
-3177, 669, 1281, 1282, 1214, 6049, 3426, 6048, 6050, 3423, 3424,
-3178, 34, 179, 857, 35, 5903, 1941, 6051, 1558, 5822, 6052,
-3179, 595, 631, 526, 1190, 4838, 4835, 4836, 6053, 6054, 5720,
-3180, 1315, 1292, 670, 608, 3533, 6056, 6055, 6057, 6058, 5088,
-3181, 16, 794, 335, 157, 5960, 5961, 3976, 3565, 1789, 6059,
-3182, 364, 454, 1013, 1053, 4441, 5851, 6060, 5636, 6061, 2565,
-3183, 76, 328, 77, 899, 3957, 3956, 1600, 5847, 5848, 6062,
-3184, 1062, 421, 1162, 422, 6064, 6063, 2940, 6065, 4264, 6066,
-3185, 606, 687, 660, 1286, 5143, 5145, 5065, 6067, 6069, 6068,
-3186, 1252, 708, 1186, 1246, 6071, 6070, 3325, 3326, 6072, 3299,
-3187, 1222, 1114, 1188, 502, 3184, 3035, 3288, 6073, 5860, 6074,
-3188, 547, 643, 1165, 601, 4987, 6075, 5730, 4990, 4989, 6076,
-3189, 241, 387, 240, 976, 4158, 4157, 3718, 6077, 6079, 6078,
-3190, 578, 1225, 1196, 644, 6081, 3199, 6080, 4994, 6083, 6082,
-3191, 977, 390, 1163, 975, 6084, 6033, 3011, 2344, 6085, 2947,
-3192, 458, 347, 1020, 311, 4375, 6087, 6086, 4374, 4102, 6088,
-3193, 1188, 587, 1184, 1269, 6034, 6089, 3173, 3380, 6036, 3381,
-3194, 1023, 312, 460, 1022, 5698, 4382, 5632, 2475, 6090, 5633,
-3195, 505, 621, 1193, 1180, 4816, 6092, 6091, 6093, 6094, 3052,
-3196, 1163, 389, 977, 974, 6022, 6095, 3011, 2960, 5679, 2343,
-3197, 748, 1192, 747, 707, 6096, 5938, 5345, 5346, 5800, 5344,
-3198, 219, 73, 218, 919, 6098, 6097, 1455, 2110, 6028, 2111,
-3199, 946, 791, 947, 227, 2250, 2252, 2254, 6099, 6101, 6100,
-3200, 985, 828, 260, 911, 2362, 6103, 6102, 2365, 2166, 5551,
-3201, 1242, 1241, 694, 1311, 3287, 6105, 6104, 3519, 3518, 5985,
-3202, 1362, 728, 733, 764, 6107, 5302, 6106, 6108, 5410, 5412,
-3203, 406, 985, 405, 259, 6110, 6109, 4216, 4214, 6111, 4212,
-3204, 636, 1192, 637, 707, 5798, 6112, 4969, 5204, 5800, 5205,
-3205, 637, 1246, 708, 707, 5879, 6072, 5207, 5205, 6113, 5209,
-3206, 561, 471, 551, 1147, 4708, 4681, 4709, 6114, 5631, 6115,
-3207, 456, 1014, 1154, 1015, 6116, 2911, 5790, 6117, 2451, 2912,
-3208, 404, 984, 985, 405, 5499, 2364, 5497, 4213, 6118, 6109,
-3209, 329, 279, 77, 816, 3962, 3831, 3959, 6119, 6121, 6120,
-3210, 33, 816, 815, 329, 5750, 1857, 5749, 3960, 6119, 6122,
-3211, 448, 854, 935, 304, 6124, 2216, 6123, 4342, 6126, 6125,
-3212, 1141, 490, 559, 1140, 6127, 4700, 6008, 2874, 6128, 6007,
-3213, 562, 1088, 957, 1087, 6130, 2708, 6129, 6131, 2710, 2706,
-3214, 33, 329, 77, 816, 3960, 3959, 3702, 5750, 6119, 6120,
-3215, 169, 168, 26, 806, 1404, 3588, 3587, 1825, 1824, 6132,
-3216, 519, 1160, 1194, 518, 6134, 3054, 6133, 4584, 5828, 6135,
-3217, 1089, 1088, 649, 1213, 2713, 6137, 6136, 3140, 3138, 6138,
-3218, 26, 807, 169, 806, 6139, 1827, 3587, 6132, 1829, 1825,
-3219, 33, 816, 2, 178, 5750, 6140, 1526, 3603, 1854, 3605,
-3220, 628, 1185, 1244, 1194, 6142, 3291, 6141, 6143, 3056, 3292,
-3221, 39, 38, 309, 861, 1562, 3919, 3918, 6144, 6146, 6145,
-3222, 30, 235, 174, 29, 3698, 6147, 3598, 1522, 3699, 3596,
-3223, 901, 819, 241, 976, 2157, 6149, 6148, 2338, 2337, 6077,
-3224, 1223, 1106, 513, 514, 3186, 5542, 5543, 6150, 5934, 4568,
-3225, 1220, 709, 1186, 1240, 6152, 6151, 3169, 3277, 6153, 3278,
-3226, 1013, 899, 781, 328, 2442, 2152, 2443, 5849, 5848, 6047,
-3227, 243, 40, 41, 820, 3722, 1564, 3723, 6154, 5902, 5753,
-3228, 1243, 1103, 1111, 522, 3289, 2780, 3290, 6155, 6157, 6156,
-3229, 39, 861, 309, 862, 6144, 6145, 3918, 6158, 1957, 6159,
-3230, 171, 27, 28, 234, 3590, 1520, 3593, 6160, 3697, 3696,
-3231, 257, 827, 199, 200, 5976, 1880, 6161, 5984, 1879, 1436,
-3232, 77, 899, 781, 222, 6062, 2152, 6045, 6162, 2067, 2070,
-3233, 901, 819, 183, 38, 2157, 1864, 2074, 6163, 5925, 5923,
-3234, 958, 482, 803, 959, 6001, 6164, 2286, 2290, 6165, 2288,
-3235, 380, 578, 1119, 599, 4778, 5953, 5954, 4850, 4876, 6166,
-3236, 416, 415, 1111, 522, 4246, 5516, 6167, 4593, 4592, 6156,
-3237, 285, 83, 84, 114, 3848, 1533, 3849, 6168, 3620, 3621,
-3238, 503, 1114, 1222, 502, 5861, 3184, 6169, 4532, 5860, 6073,
-3239, 202, 203, 58, 260, 1439, 6171, 6170, 5550, 5552, 3774,
-3240, 1156, 504, 505, 394, 6173, 4539, 6172, 6174, 4535, 4537,
-3241, 1266, 1257, 656, 1191, 3373, 6175, 5785, 3372, 3340, 5787,
-3242, 1045, 471, 1044, 323, 5629, 6176, 2541, 6177, 4415, 6178,
-3243, 857, 180, 858, 35, 1942, 1943, 1945, 6052, 6180, 6179,
-3244, 1044, 889, 1045, 323, 2537, 2539, 2541, 6178, 6181, 6177,
-3245, 1195, 1157, 632, 1191, 3059, 6183, 6182, 3248, 3046, 6184,
-3246, 63, 64, 886, 358, 1587, 6186, 6185, 4029, 4028, 6187,
-3247, 900, 35, 817, 238, 6188, 5825, 2154, 5568, 3707, 6189,
-3248, 322, 64, 886, 887, 3945, 6186, 6190, 6191, 6192, 2032,
-3249, 1165, 601, 548, 547, 6076, 4858, 6193, 5730, 4990, 4675,
-3250, 582, 1225, 1120, 578, 6194, 3198, 5943, 4779, 6081, 5944,
-3251, 67, 68, 270, 916, 1591, 3804, 3803, 6195, 6197, 6196,
-3252, 607, 651, 1211, 662, 5046, 6199, 6198, 5071, 5070, 6200,
-3253, 242, 388, 241, 974, 4161, 4160, 3721, 5677, 5678, 6201,
-3254, 529, 1096, 485, 584, 5661, 6202, 4750, 5044, 5648, 4801,
-3255, 1306, 685, 704, 1335, 6204, 5195, 6203, 3357, 6206, 6205,
-3256, 342, 31, 175, 813, 3989, 3600, 6207, 5916, 6208, 1845,
-3257, 834, 271, 272, 69, 6210, 3811, 6209, 6211, 3807, 3809,
-3258, 975, 973, 903, 244, 2336, 2331, 2334, 6212, 6214, 6213,
-3259, 582, 1225, 1121, 1120, 6194, 3200, 6215, 5943, 3198, 2814,
-3260, 1090, 1089, 583, 1214, 2716, 6217, 6216, 3144, 3143, 6218,
-3261, 1119, 1225, 1196, 578, 3197, 3199, 3062, 5953, 6081, 6080,
-3262, 1175, 1207, 603, 1075, 3107, 6220, 6219, 2998, 3105, 5929,
-3263, 944, 226, 383, 788, 6221, 4146, 5701, 2243, 6030, 5703,
-3264, 1068, 542, 441, 1006, 6223, 4655, 6222, 2625, 6225, 6224,
-3265, 1120, 1225, 1119, 578, 3198, 3197, 2811, 5944, 6081, 5953,
-3266, 1012, 237, 238, 817, 6227, 3709, 6226, 2440, 5824, 6189,
-3267, 485, 1096, 529, 968, 6202, 5661, 4750, 5811, 2738, 5810,
-3268, 1189, 531, 1001, 1161, 6229, 6228, 3037, 3038, 6230, 2939,
-3269, 17, 335, 795, 157, 3975, 6232, 6231, 3568, 6059, 1791,
-3270, 720, 1247, 1265, 1314, 6234, 3370, 6233, 6235, 3530, 3462,
-3271, 569, 574, 1117, 1161, 4772, 6237, 6236, 6238, 5957, 3060,
-3272, 1103, 1219, 522, 1243, 3166, 6239, 6157, 3289, 3309, 6155,
-3273, 681, 1247, 746, 720, 6241, 6240, 5308, 5246, 6234, 5310,
-3274, 202, 260, 58, 57, 5550, 3774, 6170, 6242, 3773, 1581,
-3275, 4, 178, 2, 816, 1414, 3605, 3540, 1855, 1854, 6140,
-3276, 746, 1247, 1265, 720, 6240, 3370, 5852, 5310, 6234, 6233,
-3277, 1262, 1223, 627, 1245, 3352, 6244, 6243, 3354, 3318, 6245,
-3278, 734, 1270, 1252, 709, 6247, 3383, 6246, 5306, 6249, 6248,
-3279, 617, 654, 1266, 656, 5039, 6251, 6250, 5051, 5054, 5785,
-3280, 1167, 642, 545, 1172, 5729, 4983, 6252, 2969, 6254, 6253,
-3281, 680, 1223, 627, 1262, 6255, 6244, 5164, 6256, 3352, 6243,
-3282, 1165, 643, 547, 1169, 6075, 4987, 5730, 2967, 6258, 6257,
-3283, 544, 543, 1164, 641, 4663, 6260, 6259, 4980, 4979, 6261,
-3284, 681, 1173, 746, 1247, 6262, 5853, 5308, 6241, 3304, 6240,
-3285, 1359, 1368, 768, 1365, 1658, 6264, 6263, 1657, 1638, 6265,
-3286, 1364, 1368, 775, 1358, 1622, 6267, 6266, 1655, 1656, 6268,
-3287, 746, 1173, 1265, 1247, 5853, 3369, 5852, 6240, 3304, 3370,
-3288, 671, 1258, 1277, 1260, 6269, 3499, 5560, 5562, 3387, 3405,
-3289, 213, 916, 834, 68, 2104, 2203, 1894, 6270, 6197, 6271,
-3290, 1308, 673, 680, 701, 6273, 5165, 6272, 6274, 5188, 5187,
-3291, 457, 1125, 1024, 1023, 6276, 2825, 6275, 5697, 2824, 2478,
-3292, 680, 673, 1308, 1262, 5165, 6273, 6272, 6256, 6277, 3508,
-3293, 23, 803, 165, 338, 6278, 1815, 3582, 3981, 6280, 6279,
-3294, 590, 1181, 511, 1116, 5577, 5515, 4821, 6281, 3013, 5513,
-3295, 756, 1357, 1354, 1369, 6283, 1654, 6282, 6284, 1653, 1651,
-3296, 371, 795, 479, 335, 6286, 6285, 4466, 4121, 6232, 4443,
-3297, 1240, 710, 678, 709, 6288, 5298, 6287, 6153, 5297, 5234,
-3298, 1259, 696, 686, 630, 6290, 5280, 6289, 6291, 5173, 5140,
-3299, 519, 518, 1194, 628, 4584, 6135, 6133, 4940, 4939, 6143,
-3300, 1277, 1258, 671, 1309, 3499, 6269, 5560, 2968, 3511, 6292,
-3301, 532, 1189, 1001, 996, 5983, 3037, 6293, 5718, 2973, 2411,
-3302, 965, 1095, 568, 378, 2732, 5639, 5638, 6294, 6295, 4878,
-3303, 1255, 1273, 1318, 761, 3394, 3171, 3538, 6296, 6298, 6297,
-3304, 1368, 1359, 768, 775, 1658, 6263, 6264, 6267, 6299, 5489,
-3305, 1169, 1167, 642, 546, 3020, 5729, 5727, 6300, 5733, 4984,
-3306, 1122, 1021, 458, 1020, 2816, 6302, 6301, 2815, 2469, 6086,
-3307, 636, 1170, 637, 1192, 6303, 5880, 4969, 5798, 3048, 6112,
-3308, 1054, 635, 1112, 1171, 6304, 5926, 2782, 2979, 6305, 2988,
-3309, 527, 1190, 526, 1162, 6306, 5720, 4610, 6307, 3042, 5721,
-3310, 650, 597, 560, 1293, 5018, 4845, 5015, 6308, 6310, 6309,
-3311, 538, 635, 1054, 1171, 4962, 6304, 6311, 6312, 6305, 2979,
-3312, 95, 128, 296, 94, 3646, 5574, 3882, 1544, 3645, 3881,
-3313, 505, 504, 1156, 1239, 4539, 6173, 6172, 6313, 6314, 3302,
-3314, 1012, 238, 900, 817, 6226, 5568, 2446, 2440, 6189, 2154,
-3315, 627, 673, 1262, 1224, 5095, 6277, 6243, 6315, 6316, 3501,
-3316, 484, 809, 341, 234, 6318, 6317, 4453, 4454, 6319, 4054,
-3317, 1294, 765, 734, 761, 6321, 5414, 6320, 6322, 5417, 5401,
-3318, 171, 808, 27, 234, 1831, 6323, 3590, 6160, 6324, 3697,
-3319, 58, 355, 880, 57, 4022, 6325, 5596, 1581, 4023, 6326,
-3320, 260, 828, 259, 57, 6103, 6327, 3775, 3773, 6328, 3771,
-3321, 56, 828, 910, 201, 6330, 2197, 6329, 6331, 1882, 2092,
-3322, 837, 920, 424, 994, 2175, 5626, 6332, 2388, 2390, 5628,
-3323, 833, 915, 66, 211, 2202, 6334, 6333, 1892, 2102, 6335,
-3324, 1082, 1083, 549, 496, 2692, 6337, 6336, 6338, 6339, 4725,
-3325, 1309, 696, 1259, 1258, 6340, 6290, 3510, 3511, 6341, 3345,
-3326, 666, 610, 1275, 717, 5079, 5617, 6342, 5243, 5232, 5964,
-3327, 1309, 1259, 686, 1316, 3510, 6289, 6343, 3477, 3537, 6344,
-3328, 594, 1258, 1243, 1219, 6346, 3343, 6345, 6347, 3342, 3309,
-3329, 259, 910, 56, 828, 6348, 6329, 3770, 6327, 2197, 6330,
-3330, 1212, 676, 1178, 1280, 6350, 6349, 3136, 3417, 6351, 3418,
-3331, 280, 1005, 307, 839, 6352, 5520, 4000, 6353, 2421, 5545,
-3332, 1002, 1064, 1155, 536, 2614, 2995, 2919, 5838, 5840, 6354,
-3333, 1280, 697, 653, 1281, 6356, 5174, 6355, 3445, 6357, 5829,
-3334, 1263, 585, 1274, 666, 6358, 5905, 1744, 6359, 5099, 5762,
-3335, 1281, 1280, 1178, 653, 3445, 3418, 3419, 5829, 6355, 6360,
-3336, 1109, 520, 1185, 1182, 6362, 6361, 3025, 3018, 6363, 3172,
-3337, 505, 1180, 1193, 1239, 6093, 3052, 6091, 6313, 3276, 3275,
-3338, 770, 767, 1354, 1360, 5454, 6365, 6364, 6366, 6367, 1650,
-3339, 1178, 1280, 676, 653, 3418, 6351, 6349, 6360, 6355, 5105,
-3340, 678, 641, 1220, 640, 5112, 6369, 6368, 5214, 4981, 6370,
-3341, 1306, 704, 1288, 1320, 6203, 6371, 3231, 3232, 6372, 3233,
-3342, 910, 259, 56, 258, 6348, 3770, 6329, 6373, 3772, 3768,
-3343, 1373, 205, 830, 912, 6375, 1886, 6374, 6376, 2096, 2199,
-3344, 637, 1192, 1170, 1246, 6112, 3048, 5880, 5879, 3307, 3306,
-3345, 1086, 565, 562, 1087, 6378, 4723, 6377, 2707, 6379, 6131,
-3346, 1085, 565, 1178, 611, 6380, 5908, 3135, 6381, 4894, 5909,
-3347, 676, 1212, 1178, 611, 6350, 3136, 6349, 5106, 6382, 5909,
-3348, 1081, 496, 949, 1082, 6384, 6383, 2682, 2686, 6338, 2684,
-3349, 793, 948, 334, 476, 2256, 6386, 6385, 6387, 5771, 4427,
-3350, 1210, 1209, 1079, 598, 3120, 3116, 3118, 6388, 6390, 6389,
-3351, 1309, 1316, 686, 723, 3477, 6344, 6343, 6391, 5671, 5257,
-3352, 232, 804, 375, 339, 5614, 5522, 4130, 4052, 5615, 4129,
-3353, 1306, 667, 704, 685, 6392, 5194, 6203, 6204, 5137, 5195,
-3354, 1197, 530, 586, 608, 5656, 4807, 5657, 6012, 4883, 4885,
-3355, 727, 752, 1265, 720, 5363, 6394, 6393, 5276, 5361, 6233,
-3356, 1057, 1106, 514, 406, 2765, 5934, 5932, 6395, 6396, 4567,
-3357, 45, 867, 44, 312, 6398, 6397, 1568, 3924, 6399, 3925,
-3358, 510, 1113, 1181, 1179, 5660, 3014, 6400, 5658, 3006, 3164,
-3359, 594, 1259, 1219, 630, 6401, 3344, 6347, 4947, 6291, 6402,
-3360, 1123, 498, 460, 1124, 6403, 4516, 5746, 2823, 6404, 5634,
-3361, 1358, 775, 780, 1359, 6268, 5491, 6405, 1659, 6299, 6406,
-3362, 257, 256, 199, 827, 3766, 6407, 6161, 5976, 6408, 1880,
-3363, 736, 767, 770, 1360, 5425, 5454, 5464, 5978, 6367, 6366,
-3364, 624, 510, 511, 1181, 4928, 4557, 4929, 5576, 6400, 5515,
-3365, 793, 156, 228, 15, 1786, 5990, 6409, 6410, 3563, 3685,
-3366, 550, 487, 1138, 466, 4783, 6412, 6411, 4680, 4473, 6413,
-3367, 771, 751, 753, 1366, 5440, 5367, 5441, 6414, 6416, 6415,
-3368, 474, 1052, 363, 1051, 6417, 5939, 4422, 6418, 2562, 6419,
-3369, 537, 435, 1065, 434, 4639, 6421, 6420, 4638, 4304, 6422,
-3370, 859, 37, 182, 860, 5802, 6423, 1947, 1951, 5804, 1949,
-3371, 107, 179, 839, 1375, 1904, 2071, 1906, 6424, 6426, 6425,
-3372, 307, 839, 34, 280, 5545, 6427, 3915, 4000, 6353, 3963,
-3373, 140, 937, 306, 855, 2151, 6429, 6428, 1937, 2190, 6430,
-3374, 34, 839, 307, 857, 6427, 5545, 3915, 6051, 2225, 5521,
-3375, 1145, 486, 470, 576, 6432, 4470, 6431, 5598, 4769, 4768,
-3376, 449, 1010, 450, 548, 5808, 6433, 4349, 4847, 5807, 4745,
-3377, 1351, 1365, 757, 1350, 1648, 6435, 6434, 1649, 1642, 6436,
-3378, 369, 1081, 476, 948, 6437, 5770, 4428, 6438, 2681, 5771,
-3379, 1351, 773, 1327, 739, 6440, 6439, 1729, 6441, 5445, 6442,
-3380, 1351, 1350, 757, 739, 1649, 6436, 6434, 6441, 6443, 5387,
-3381, 1291, 762, 759, 1326, 6445, 5413, 6444, 2689, 6446, 5981,
-3382, 1349, 1368, 1362, 764, 1621, 1625, 1624, 6447, 6448, 6108,
-3383, 53, 255, 197, 198, 3759, 6450, 6449, 6451, 6452, 1434,
-3384, 290, 435, 1066, 927, 4302, 6454, 6453, 6455, 6456, 2620,
-3385, 590, 512, 1174, 1116, 4822, 6458, 6457, 6281, 6459, 2993,
-3386, 46, 823, 248, 905, 6461, 6460, 3738, 6462, 2192, 6463,
-3387, 33, 816, 77, 2, 5750, 6120, 3702, 1526, 6140, 1601,
-3388, 760, 1358, 1319, 742, 6465, 1711, 6464, 5396, 6467, 6466,
-3389, 308, 344, 37, 860, 3997, 3996, 3916, 5803, 6468, 5804,
-3390, 175, 31, 176, 813, 3600, 3599, 1411, 1845, 6208, 1846,
-3391, 1200, 1268, 614, 1296, 3471, 6470, 6469, 3473, 3472, 6471,
-3392, 603, 1074, 1175, 1075, 5930, 2997, 6219, 5929, 2665, 2998,
-3393, 769, 1372, 1352, 772, 6473, 1614, 6472, 5438, 6475, 6474,
-3394, 984, 1104, 403, 983, 2757, 6477, 6476, 2593, 2758, 6478,
-3395, 764, 1368, 775, 774, 6448, 6267, 5483, 5450, 6479, 5481,
-3396, 737, 1352, 1364, 772, 6481, 1615, 6480, 5439, 6474, 6482,
-3397, 889, 888, 359, 1044, 2038, 5820, 5818, 2537, 2536, 6483,
-3398, 742, 774, 1364, 772, 5473, 6485, 6484, 5465, 5451, 6482,
-3399, 576, 1202, 1145, 1234, 6486, 3086, 5598, 5600, 3262, 3240,
-3400, 1302, 668, 648, 1267, 6488, 5083, 6487, 3487, 6490, 6489,
-3401, 1365, 1338, 777, 1359, 1666, 6492, 6491, 1657, 1667, 6493,
-3402, 527, 596, 595, 1218, 4839, 4841, 4837, 6494, 6496, 6495,
-3403, 1330, 729, 1309, 732, 6498, 6497, 1748, 6499, 5304, 6500,
-3404, 1098, 534, 613, 632, 6502, 4951, 6501, 6503, 4952, 4954,
-3405, 1375, 839, 78, 34, 6425, 6505, 6504, 6506, 6427, 3833,
-3406, 1325, 1280, 676, 1279, 3421, 6351, 6507, 3429, 3428, 6508,
-3407, 980, 508, 397, 1107, 6510, 4546, 6509, 2766, 6017, 6511,
-3408, 736, 1355, 1360, 1326, 6512, 1644, 5978, 5979, 1706, 1707,
-3409, 1101, 591, 518, 517, 6513, 4938, 5826, 5591, 4826, 4581,
-3410, 543, 542, 1068, 1168, 4659, 6223, 6514, 6515, 6516, 2962,
-3411, 639, 640, 1186, 1168, 4978, 6518, 6517, 6519, 6520, 3028,
-3412, 1358, 1359, 780, 1334, 1659, 6406, 6405, 1674, 1675, 6521,
-3413, 452, 456, 1154, 1015, 4370, 5790, 5788, 5534, 6117, 2912,
-3414, 412, 411, 1109, 519, 4234, 6523, 6522, 4583, 4582, 6524,
-3415, 738, 1371, 779, 767, 6526, 6525, 5477, 5426, 6527, 5476,
-3416, 344, 1015, 1016, 860, 5836, 2454, 5835, 6468, 2450, 2452,
-3417, 1066, 435, 1065, 927, 6454, 6421, 2650, 2620, 6456, 2616,
-3418, 243, 244, 975, 820, 3727, 6212, 6528, 6154, 6529, 2335,
-3419, 38, 860, 344, 861, 6530, 6468, 3998, 6146, 1954, 6531,
-3420, 648, 1201, 605, 556, 6533, 6532, 5009, 5006, 6534, 4871,
-3421, 489, 464, 1134, 552, 4482, 6535, 5958, 4684, 4683, 6536,
-3422, 779, 1367, 771, 1366, 6538, 6537, 5490, 6539, 1611, 6414,
-3423, 1310, 1339, 1342, 699, 3150, 1665, 3151, 6540, 6542, 6541,
-3424, 397, 979, 396, 906, 6544, 6543, 4189, 6545, 2347, 6546,
-3425, 1189, 644, 613, 574, 6548, 4993, 6547, 5955, 4992, 4897,
-3426, 668, 1324, 721, 1313, 6550, 6549, 5282, 6551, 3201, 6552,
-3427, 1331, 721, 1353, 1324, 6554, 6553, 1689, 1719, 6549, 1697,
-3428, 757, 1337, 1350, 1347, 6555, 1700, 6436, 6556, 1701, 1669,
-3429, 403, 257, 404, 827, 4206, 4208, 4210, 6557, 5976, 5977,
-3430, 859, 1015, 308, 860, 2449, 6558, 5801, 1951, 2450, 5803,
-3431, 1199, 1285, 647, 1230, 3468, 5538, 6559, 3076, 3434, 6560,
-3432, 1090, 1214, 583, 1215, 3144, 6218, 6216, 3146, 3148, 6561,
-3433, 1335, 730, 1320, 1328, 6563, 6562, 1616, 1617, 6564, 1618,
-3434, 1178, 611, 649, 653, 5909, 5013, 5907, 6360, 5036, 5035,
-3435, 351, 461, 1028, 1027, 4385, 6566, 6565, 6567, 6568, 2490,
-3436, 631, 686, 1284, 664, 5141, 6570, 6569, 5075, 5150, 6571,
-3437, 548, 495, 1158, 450, 4746, 6573, 6572, 4745, 4510, 6574,
-3438, 307, 345, 858, 1005, 4104, 6575, 5519, 5520, 6576, 2567,
-3439, 427, 922, 1001, 972, 6578, 2409, 6577, 6579, 2328, 2410,
-3440, 1012, 817, 856, 237, 2440, 2153, 2437, 6227, 5824, 6580,
-3441, 1331, 698, 1313, 1317, 6582, 6581, 3202, 3282, 6583, 3411,
-3442, 193, 48, 194, 871, 6585, 6584, 1430, 1982, 6586, 1983,
-3443, 1222, 504, 1156, 1056, 6587, 6173, 3190, 3183, 6588, 2922,
-3444, 871, 1027, 351, 872, 2485, 6567, 6589, 1987, 2486, 6590,
-3445, 229, 797, 18, 159, 6592, 6591, 3686, 6593, 1797, 3571,
-3446, 1297, 689, 726, 741, 6595, 5272, 6594, 6596, 5327, 5326,
-3447, 474, 1050, 1152, 1051, 6598, 2905, 6597, 6418, 2559, 2906,
-3448, 1110, 523, 417, 1103, 6599, 4596, 5935, 2775, 6601, 6600,
-3449, 4, 2, 143, 1374, 3540, 3539, 1378, 6602, 6604, 6603,
-3450, 32, 33, 815, 329, 1525, 5749, 6605, 3961, 3960, 6122,
-3451, 1297, 741, 726, 754, 6596, 5326, 6594, 6606, 5371, 5370,
-3452, 628, 591, 518, 1194, 4941, 4938, 4939, 6143, 6607, 6135,
-3453, 472, 1049, 473, 325, 6609, 6608, 4488, 4418, 6610, 4420,
-3454, 1329, 763, 1340, 1338, 6611, 5969, 1680, 1676, 6612, 1681,
-3455, 1353, 1348, 750, 738, 1660, 6614, 6613, 6615, 6616, 5355,
-3456, 936, 1010, 449, 854, 2432, 5808, 6617, 2189, 2433, 6618,
-3457, 461, 1128, 1129, 1027, 6620, 2838, 6619, 6568, 2834, 2836,
-3458, 351, 314, 871, 49, 4061, 6621, 6589, 4015, 3928, 6622,
-3459, 195, 351, 873, 872, 6624, 6623, 1988, 1986, 6590, 1990,
-3460, 351, 195, 873, 50, 6624, 1988, 6623, 4014, 6626, 6625,
-3461, 617, 1225, 646, 1257, 6628, 6627, 5024, 6629, 3355, 6630,
-3462, 668, 1302, 675, 1324, 6488, 5988, 5104, 6550, 3522, 5989,
-3463, 1233, 557, 605, 1201, 6632, 4870, 6631, 3238, 6633, 6532,
-3464, 1098, 632, 1195, 1157, 6503, 6182, 3057, 2924, 6183, 3059,
-3465, 668, 675, 725, 1324, 5104, 5269, 5268, 6550, 5989, 6634,
-3466, 108, 839, 921, 280, 1905, 2116, 2115, 6635, 6353, 6636,
-3467, 1013, 223, 782, 454, 5850, 5855, 2444, 5851, 4363, 5856,
-3468, 593, 521, 1243, 629, 4829, 6638, 6637, 5030, 4944, 6639,
-3469, 891, 324, 1046, 360, 6641, 6640, 2543, 6642, 4094, 6643,
-3470, 405, 1106, 514, 513, 6644, 5934, 4566, 4565, 5542, 4568,
-3471, 958, 802, 374, 957, 2285, 6645, 6000, 2287, 2283, 6646,
-3472, 403, 256, 257, 827, 4205, 3766, 4206, 6557, 6408, 5976,
-3473, 909, 256, 403, 827, 6648, 4205, 6647, 2196, 6408, 6557,
-3474, 206, 883, 205, 60, 2019, 2018, 1442, 5689, 6650, 6649,
-3475, 357, 884, 61, 883, 6652, 6651, 4027, 6653, 2023, 6654,
-3476, 42, 41, 903, 244, 1565, 5752, 6655, 3726, 3725, 6213,
-3477, 45, 905, 247, 822, 6657, 6656, 3735, 6658, 2160, 6659,
-3478, 730, 1335, 1320, 704, 6563, 1616, 6562, 5340, 6205, 6372,
-3479, 501, 609, 1184, 587, 4917, 6661, 6660, 4808, 4918, 6089,
-3480, 1123, 455, 1122, 1021, 5748, 6662, 2820, 2818, 6663, 2816,
-3481, 704, 1335, 703, 730, 6205, 6664, 5196, 5340, 6563, 5391,
-3482, 1166, 541, 638, 1099, 5705, 4971, 5863, 2956, 6665, 5865,
-3483, 736, 1355, 738, 1371, 6512, 6666, 5323, 6667, 1608, 6526,
-3484, 274, 72, 836, 918, 3816, 6669, 6668, 6670, 5536, 2205,
-3485, 210, 267, 209, 832, 6672, 6671, 1446, 1889, 5549, 1890,
-3486, 320, 357, 61, 883, 4067, 4027, 3940, 6673, 6653, 6654,
-3487, 320, 883, 61, 60, 6673, 6654, 3940, 3941, 6650, 1584,
-3488, 1307, 1272, 658, 1234, 3366, 5776, 5774, 3507, 3388, 6674,
-3489, 747, 1273, 1255, 761, 5559, 3394, 5937, 5424, 6298, 6296,
-3490, 472, 1049, 325, 1048, 6609, 6610, 4418, 6675, 2553, 6676,
-3491, 606, 1228, 492, 619, 6678, 6677, 4874, 4916, 6679, 4914,
-3492, 460, 498, 1123, 455, 4516, 6403, 5746, 4459, 4517, 5748,
-3493, 61, 883, 206, 60, 6654, 2019, 6680, 1584, 6650, 5689,
-3494, 326, 72, 894, 895, 3953, 6682, 6681, 6683, 6684, 2056,
-3495, 586, 1271, 1227, 1292, 6685, 3385, 5610, 6686, 3482, 3456,
-3496, 1159, 422, 994, 1062, 6688, 6687, 2932, 2933, 6065, 2649,
-3497, 423, 994, 1097, 1159, 6689, 2785, 5723, 5710, 2932, 2942,
-3498, 326, 894, 362, 1050, 6681, 6690, 4096, 6691, 2554, 6692,
-3499, 1228, 579, 488, 1130, 6694, 4785, 6693, 3217, 6696, 6695,
-3500, 665, 586, 1271, 652, 5078, 6685, 6697, 5077, 5028, 6698,
-3501, 1317, 685, 703, 698, 6700, 5191, 6699, 6583, 5176, 5192,
-3502, 1241, 1223, 680, 1262, 3280, 6255, 6701, 3353, 3352, 6256,
-3503, 1227, 586, 567, 652, 5610, 4806, 5608, 6702, 5028, 5027,
-3504, 566, 619, 1198, 652, 4915, 6704, 6703, 5026, 5029, 6705,
-3505, 517, 1105, 408, 1060, 6707, 6706, 4575, 5593, 2759, 5813,
-3506, 1227, 566, 1198, 652, 6708, 6703, 3215, 6702, 5026, 6705,
-3507, 217, 894, 72, 895, 2052, 6682, 5537, 2054, 2056, 6684,
-3508, 1377, 265, 264, 913, 6710, 3790, 6709, 6711, 6713, 6712,
-3509, 546, 545, 1167, 642, 4669, 6252, 5733, 4984, 4983, 5729,
-3510, 1308, 673, 1310, 1262, 6273, 6714, 3224, 3508, 6277, 3515,
-3511, 72, 326, 894, 362, 3953, 6681, 6682, 4036, 4096, 6690,
-3512, 1364, 774, 775, 1368, 6485, 5481, 6266, 1622, 6479, 6267,
-3513, 72, 217, 216, 894, 5537, 1453, 5535, 6682, 2052, 2051,
-3514, 1043, 470, 1145, 486, 6715, 6431, 2884, 6716, 4470, 6432,
-3515, 549, 1212, 581, 577, 6717, 5511, 4797, 4774, 6718, 4796,
-3516, 253, 252, 825, 981, 3754, 6720, 6719, 5758, 6721, 2354,
-3517, 1219, 1259, 594, 1258, 3344, 6401, 6347, 3342, 3345, 6346,
-3518, 175, 812, 342, 813, 1843, 6722, 6207, 1845, 1847, 5916,
-3519, 661, 645, 1298, 1261, 5068, 6724, 6723, 6725, 5541, 3470,
-3520, 559, 1141, 1201, 556, 6008, 3234, 6021, 4703, 6726, 6534,
-3521, 560, 491, 561, 1148, 4705, 4707, 4710, 6043, 6728, 6727,
-3522, 362, 894, 72, 71, 6690, 6682, 4036, 4037, 5676, 1595,
-3523, 498, 530, 460, 1124, 4776, 4619, 4516, 6404, 6729, 5634,
-3524, 1219, 1259, 1221, 630, 3344, 3358, 3181, 6402, 6291, 6730,
-3525, 1373, 205, 882, 60, 6375, 2016, 6731, 6732, 6649, 6733,
-3526, 1325, 718, 716, 719, 6735, 5237, 6734, 6736, 5241, 5240,
-3527, 72, 894, 216, 71, 6682, 2051, 5535, 1595, 5676, 5674,
-3528, 1066, 927, 845, 290, 2620, 2180, 2617, 6453, 6455, 6737,
-3529, 1125, 457, 1024, 370, 6276, 6275, 2825, 6738, 4373, 6739,
-3530, 372, 336, 229, 952, 4123, 4049, 4124, 6740, 6742, 6741,
-3531, 667, 1293, 1288, 597, 6744, 3526, 6743, 5081, 6310, 6745,
-3532, 1263, 1274, 1288, 666, 1744, 1746, 1745, 6359, 5762, 6746,
-3533, 1199, 1130, 1131, 579, 3194, 2844, 3072, 6747, 6696, 6748,
-3534, 615, 664, 595, 1217, 5117, 5076, 5138, 5526, 6750, 6749,
-3535, 823, 46, 248, 249, 6461, 3738, 6460, 6751, 3740, 3742,
-3536, 441, 542, 1068, 543, 4655, 6223, 6222, 4657, 4659, 6514,
-3537, 367, 1115, 939, 938, 6753, 2794, 6752, 6754, 2793, 2230,
-3538, 823, 1058, 248, 905, 2585, 6755, 6460, 2192, 2586, 6463,
-3539, 367, 454, 1115, 938, 4364, 6756, 6753, 6754, 6757, 2793,
-3540, 146, 145, 7, 783, 1381, 3546, 3545, 1756, 1755, 6758,
-3541, 25, 24, 339, 167, 1517, 3984, 3983, 3586, 3583, 6759,
-3542, 260, 829, 911, 203, 6760, 2198, 5551, 5552, 1884, 2094,
-3543, 825, 981, 252, 907, 2354, 6721, 6720, 2194, 2351, 6761,
-3544, 1171, 1170, 636, 1192, 2987, 6303, 6762, 3049, 3048, 5798,
-3545, 3, 179, 107, 1375, 1415, 1904, 1460, 6763, 6426, 6424,
-3546, 55, 910, 56, 258, 6764, 6329, 1579, 3767, 6373, 3768,
-3547, 1058, 506, 1156, 1180, 6766, 6765, 3010, 3012, 6767, 3016,
-3548, 257, 200, 199, 54, 5984, 1436, 6161, 3764, 6769, 6768,
-3549, 1233, 1201, 605, 1307, 3238, 6532, 6631, 3505, 3504, 6770,
-3550, 257, 54, 199, 256, 3764, 6768, 6161, 3766, 3762, 6407,
-3551, 430, 285, 286, 924, 4287, 3853, 4288, 5884, 6771, 5883,
-3552, 45, 46, 868, 349, 1569, 6773, 6772, 4011, 4010, 5509,
-3553, 579, 1228, 488, 606, 6694, 6693, 4785, 4875, 6678, 4873,
-3554, 614, 675, 668, 1302, 5102, 5104, 5084, 6774, 5988, 6488,
-3555, 822, 190, 45, 905, 1869, 6775, 6658, 2160, 2083, 6657,
-3556, 808, 377, 340, 234, 6777, 4134, 6776, 6324, 4133, 4081,
-3557, 20, 337, 162, 799, 3980, 6778, 3574, 6779, 5967, 1804,
-3558, 905, 45, 247, 248, 6657, 3735, 6656, 6463, 3737, 3739,
-3559, 1243, 522, 594, 1219, 6155, 4831, 6345, 3309, 6239, 6347,
-3560, 870, 47, 350, 313, 6781, 4013, 6780, 6782, 3926, 4060,
-3561, 214, 213, 834, 68, 1450, 1894, 1893, 6783, 6270, 6271,
-3562, 748, 709, 1252, 708, 5368, 6248, 6784, 5347, 5213, 6071,
-3563, 20, 19, 230, 161, 1512, 3689, 3688, 3575, 3572, 6785,
-3564, 682, 1341, 1298, 659, 6787, 3090, 6786, 5127, 6789, 6788,
-3565, 369, 792, 227, 947, 6791, 6790, 4118, 6792, 2253, 6100,
-3566, 271, 69, 834, 68, 3807, 6211, 6210, 3806, 1592, 6271,
-3567, 144, 6, 782, 223, 3544, 6793, 1752, 6794, 3674, 5855,
-3568, 65, 267, 210, 915, 3795, 6672, 6795, 6796, 6797, 2103,
-3569, 633, 1191, 632, 1157, 6798, 6184, 4957, 6799, 3046, 6183,
-3570, 833, 212, 67, 916, 1891, 6801, 6800, 2171, 2105, 6195,
-3571, 548, 601, 1165, 1183, 4858, 6076, 6193, 6802, 5681, 3034,
-3572, 560, 1203, 1149, 1235, 6803, 3246, 6042, 6044, 3247, 3245,
-3573, 916, 269, 67, 833, 6804, 3801, 6195, 2171, 6805, 6800,
-3574, 15, 334, 155, 14, 3973, 6806, 3564, 1507, 3974, 3561,
-3575, 925, 431, 1063, 432, 5875, 5912, 2609, 5876, 4295, 5911,
-3576, 829, 986, 260, 911, 2366, 6807, 6760, 2198, 2367, 5551,
-3577, 617, 498, 582, 1226, 4911, 4855, 5023, 6808, 6810, 6809,
-3578, 734, 710, 745, 1270, 5307, 5376, 5390, 6247, 6812, 6811,
-3579, 758, 1300, 755, 743, 6814, 6813, 5388, 5389, 6815, 5377,
-3580, 335, 795, 157, 794, 6232, 1791, 6059, 5961, 1793, 1789,
-3581, 1101, 516, 517, 1105, 6816, 4577, 5591, 2762, 6817, 6707,
-3582, 1288, 666, 704, 667, 6746, 5197, 6371, 6743, 5101, 5194,
-3583, 425, 970, 920, 971, 6818, 2916, 5893, 6819, 2327, 2571,
-3584, 971, 278, 838, 920, 6821, 6820, 2326, 2571, 5894, 2395,
-3585, 793, 334, 155, 15, 6385, 6806, 1785, 6410, 3973, 3564,
-3586, 1111, 522, 415, 521, 6156, 4592, 5516, 6822, 4594, 4590,
-3587, 547, 1070, 1165, 1169, 5731, 2952, 5730, 6257, 2965, 2967,
-3588, 76, 838, 279, 278, 6824, 6823, 3830, 3828, 6820, 3832,
-3589, 561, 1235, 1202, 1290, 6826, 3244, 6825, 6827, 3503, 3453,
-3590, 699, 753, 1342, 740, 5365, 6828, 6541, 5185, 5366, 6829,
-3591, 833, 990, 268, 915, 2379, 6831, 6830, 2202, 2377, 6832,
-3592, 845, 927, 120, 290, 2180, 2130, 1917, 6737, 6455, 6833,
-3593, 240, 818, 901, 997, 6835, 2114, 6834, 6836, 2397, 2396,
-3594, 1000, 1004, 847, 437, 2419, 2418, 2406, 6837, 6839, 6838,
-3595, 694, 1311, 1241, 695, 5985, 3518, 6105, 5266, 5687, 6840,
-3596, 583, 612, 571, 1215, 5003, 4896, 4799, 6561, 6842, 6841,
-3597, 1184, 501, 1163, 500, 6660, 6032, 3023, 6843, 4526, 6023,
-3598, 1337, 1344, 739, 1350, 1731, 6845, 6844, 1700, 1702, 6443,
-3599, 623, 1181, 624, 1238, 6846, 5576, 4930, 6847, 3272, 6848,
-3600, 672, 620, 1254, 587, 5094, 6850, 6849, 5093, 4812, 6035,
-3601, 894, 362, 325, 71, 6690, 4072, 6851, 5676, 4037, 3950,
-3602, 1269, 1256, 679, 1250, 3444, 6853, 6852, 3414, 3338, 6854,
-3603, 1250, 1269, 1249, 663, 3414, 3413, 3348, 6855, 6857, 6856,
-3604, 617, 1225, 582, 646, 6628, 6194, 5023, 5024, 6627, 4997,
-3605, 120, 927, 121, 290, 2130, 2129, 1474, 6833, 6455, 6858,
-3606, 221, 838, 76, 278, 1902, 6824, 6859, 6860, 6820, 3828,
-3607, 243, 389, 977, 390, 4164, 6095, 6861, 4166, 4168, 6084,
-3608, 683, 1238, 693, 624, 6863, 6862, 5265, 5129, 6848, 5167,
-3609, 400, 399, 253, 982, 4198, 4194, 4196, 5738, 5760, 5761,
-3610, 660, 1199, 606, 1286, 6865, 6864, 5065, 6068, 3483, 6067,
-3611, 559, 1296, 1200, 614, 6867, 3473, 6866, 4899, 6471, 6469,
-3612, 472, 325, 361, 1048, 4418, 4095, 4416, 6675, 6676, 6868,
-3613, 278, 971, 838, 279, 6821, 2326, 6820, 3832, 6869, 6823,
-3614, 1232, 1296, 1200, 559, 3488, 3473, 3083, 6006, 6867, 6866,
-3615, 782, 454, 330, 938, 5856, 4362, 5854, 2226, 6757, 6870,
-3616, 546, 446, 547, 1070, 4668, 4670, 4672, 6871, 6872, 5731,
-3617, 52, 874, 316, 875, 6874, 6873, 3933, 6875, 1996, 6876,
-3618, 330, 783, 782, 938, 5971, 1757, 5854, 6870, 2227, 2226,
-3619, 23, 232, 166, 803, 3693, 5650, 3581, 6278, 5651, 1816,
-3620, 254, 908, 826, 982, 6878, 2195, 6877, 6879, 2355, 2357,
-3621, 469, 468, 1142, 1041, 4409, 6880, 6013, 6015, 6881, 2876,
-3622, 367, 783, 330, 938, 6882, 5971, 4114, 6754, 2227, 6870,
-3623, 469, 557, 1142, 468, 4694, 6883, 6013, 4409, 4695, 6880,
-3624, 609, 663, 1249, 1269, 5073, 6856, 6884, 6885, 6857, 3413,
-3625, 703, 685, 1317, 1335, 5191, 6700, 6699, 6664, 6206, 3283,
-3626, 1142, 469, 1143, 557, 6013, 6014, 2880, 6883, 4694, 6886,
-3627, 133, 933, 99, 132, 2142, 6887, 3655, 1486, 2143, 3654,
-3628, 243, 389, 242, 977, 4164, 4163, 3724, 6861, 6095, 6888,
-3629, 1155, 535, 536, 1064, 5654, 4636, 6354, 2995, 5653, 5840,
-3630, 371, 949, 496, 950, 6889, 6383, 4513, 6890, 2263, 6891,
-3631, 988, 411, 1109, 412, 6892, 6523, 2771, 6893, 4234, 6522,
-3632, 371, 949, 228, 476, 6889, 6894, 4122, 4429, 5769, 4426,
-3633, 559, 490, 1141, 556, 4700, 6127, 6008, 4703, 4693, 6726,
-3634, 932, 443, 851, 299, 5741, 6895, 2213, 5742, 4327, 6896,
-3635, 264, 988, 265, 411, 6898, 6897, 3790, 4229, 6892, 4230,
-3636, 228, 156, 793, 794, 5990, 1786, 6409, 5959, 1788, 1790,
-3637, 1176, 598, 1210, 1080, 6899, 6388, 3301, 2999, 6900, 3119,
-3638, 747, 752, 1273, 761, 5403, 6901, 5559, 5424, 5423, 6298,
-3639, 920, 838, 221, 278, 2395, 1902, 2112, 5894, 6820, 6860,
-3640, 580, 1081, 496, 476, 6902, 6384, 4792, 4790, 5770, 4771,
-3641, 613, 533, 1098, 532, 4950, 6903, 6501, 4949, 4627, 5982,
-3642, 658, 618, 1272, 698, 5061, 6904, 5776, 5273, 5177, 5777,
-3643, 1320, 717, 1328, 730, 6906, 6905, 1618, 6562, 5288, 6564,
-3644, 440, 296, 441, 849, 4318, 4320, 4322, 6907, 6909, 6908,
-3645, 296, 127, 128, 849, 6910, 1481, 5574, 6909, 1926, 1925,
-3646, 701, 744, 1339, 751, 5335, 6912, 6911, 5357, 5399, 6913,
-3647, 420, 1108, 992, 993, 6915, 2769, 6914, 6916, 2768, 2598,
-3648, 1086, 1087, 562, 956, 2707, 6131, 6377, 2703, 2705, 6917,
-3649, 396, 506, 1058, 979, 4541, 6766, 6918, 6543, 6919, 2588,
-3650, 736, 1346, 1326, 762, 6920, 1717, 5979, 5418, 6921, 6446,
-3651, 528, 1218, 527, 1159, 6922, 6494, 4613, 5708, 3185, 6923,
-3652, 731, 711, 1304, 665, 5293, 6925, 6924, 5292, 5215, 6926,
-3653, 1373, 60, 882, 59, 6732, 6733, 6731, 6927, 1583, 6928,
-3654, 1200, 559, 1139, 1232, 6866, 6929, 3080, 3083, 6006, 3081,
-3655, 731, 665, 1304, 1287, 5292, 6926, 6924, 6930, 6931, 3267,
-3656, 764, 757, 1365, 1362, 5411, 6435, 6932, 6108, 6933, 1637,
-3657, 297, 95, 129, 128, 3884, 3647, 6025, 5573, 3646, 1482,
-3658, 129, 850, 297, 931, 1928, 5834, 6025, 2138, 2212, 5565,
-3659, 297, 95, 96, 129, 3884, 1545, 3885, 6025, 3647, 3648,
-3660, 166, 165, 23, 803, 1401, 3582, 3581, 1816, 1815, 6278,
-3661, 830, 264, 206, 263, 6935, 6934, 1885, 5691, 3787, 5690,
-3662, 932, 443, 298, 850, 5741, 4326, 5740, 2185, 6936, 5833,
-3663, 1099, 1003, 1166, 541, 2747, 2954, 2956, 6665, 5707, 5705,
-3664, 929, 92, 294, 125, 6938, 3875, 6937, 2134, 3640, 6939,
-3665, 1090, 960, 375, 959, 2715, 5524, 5529, 2714, 2293, 5523,
-3666, 128, 931, 296, 849, 2139, 5566, 5574, 1925, 2184, 6909,
-3667, 668, 1267, 1302, 1313, 6490, 3487, 6488, 6551, 1733, 3523,
-3668, 298, 850, 443, 442, 5833, 6936, 4326, 4324, 6940, 4328,
-3669, 548, 450, 1158, 1010, 4745, 6574, 6572, 5807, 6433, 2930,
-3670, 439, 541, 540, 1003, 4651, 4653, 4649, 6941, 5707, 5706,
-3671, 703, 1317, 1331, 1335, 6699, 3282, 6942, 6664, 3283, 1716,
-3672, 1251, 1238, 755, 1300, 3321, 6944, 6943, 3479, 3478, 6813,
-3673, 306, 104, 140, 855, 3911, 3667, 6428, 6430, 6945, 1937,
-3674, 1286, 1228, 606, 619, 3498, 6678, 6067, 6946, 6679, 4916,
-3675, 306, 105, 140, 104, 3912, 3668, 6428, 3911, 1554, 3667,
-3676, 408, 986, 407, 261, 6948, 6947, 4222, 4220, 6949, 4218,
-3677, 1198, 619, 1286, 1271, 6704, 6946, 3436, 3386, 6950, 3437,
-3678, 439, 1004, 540, 438, 6952, 6951, 4649, 4316, 6953, 4648,
-3679, 429, 842, 923, 284, 6954, 2222, 5714, 4284, 6955, 5765,
-3680, 924, 114, 84, 115, 2124, 3621, 6956, 2123, 1468, 3622,
-3681, 1364, 1356, 742, 772, 1634, 6957, 6484, 6482, 6958, 5465,
-3682, 1302, 614, 648, 668, 6774, 5008, 6487, 6488, 5084, 5083,
-3683, 287, 116, 925, 843, 6959, 2126, 5874, 6960, 1913, 2178,
-3684, 209, 267, 914, 832, 6671, 5548, 2100, 1890, 5549, 2201,
-3685, 205, 882, 60, 883, 2016, 6733, 6649, 2018, 2020, 6650,
-3686, 296, 931, 441, 849, 5566, 5564, 4320, 6909, 2184, 6908,
-3687, 611, 577, 581, 1212, 4892, 4796, 4893, 6382, 6718, 5511,
-3688, 127, 930, 94, 126, 2136, 6961, 3644, 1480, 2137, 3643,
-3689, 183, 860, 38, 861, 1950, 6530, 5923, 1952, 1954, 6146,
-3690, 917, 215, 1376, 835, 2106, 6963, 6962, 2204, 1896, 6964,
-3691, 463, 489, 1133, 564, 4480, 5947, 5945, 4718, 4717, 6965,
-3692, 279, 971, 425, 278, 6869, 6819, 4272, 3832, 6821, 4271,
-3693, 425, 971, 920, 278, 6819, 2571, 5893, 4271, 6821, 5894,
-3694, 1291, 762, 1326, 1346, 6445, 6446, 2689, 2688, 6921, 1717,
-3695, 238, 36, 900, 35, 3708, 5569, 5568, 3707, 1559, 6188,
-3696, 128, 127, 296, 94, 1481, 6910, 5574, 3645, 3644, 3881,
-3697, 647, 564, 1230, 552, 5040, 6966, 6560, 5002, 4720, 6967,
-3698, 1298, 1305, 659, 1341, 3089, 6968, 6788, 3090, 1742, 6789,
-3699, 1354, 770, 1343, 756, 6364, 6969, 1673, 6282, 5432, 6970,
-3700, 1107, 508, 622, 509, 6017, 4819, 6018, 6971, 4551, 4820,
-3701, 760, 1334, 758, 743, 6973, 6972, 5397, 5394, 6974, 5389,
-3702, 1194, 1248, 591, 1224, 3310, 6975, 6607, 3195, 3311, 6976,
-3703, 329, 971, 425, 279, 6977, 6819, 4273, 3962, 6869, 4272,
-3704, 329, 971, 815, 425, 6977, 2324, 6122, 4273, 6819, 6978,
-3705, 182, 860, 38, 183, 1949, 6530, 6979, 1419, 1950, 5923,
-3706, 37, 344, 38, 860, 3996, 3998, 1561, 5804, 6468, 6530,
-3707, 182, 183, 38, 901, 1419, 5923, 6979, 2075, 2074, 6163,
-3708, 1027, 871, 314, 1026, 2485, 6621, 6980, 2487, 2483, 6981,
-3709, 826, 909, 198, 255, 2164, 2091, 1877, 6982, 6983, 6452,
-3710, 350, 871, 314, 48, 6984, 6621, 4084, 4012, 6586, 3929,
-3711, 834, 69, 272, 917, 6211, 3809, 6209, 2172, 6986, 6985,
-3712, 939, 784, 224, 783, 2229, 5700, 6987, 2228, 1760, 6988,
-3713, 1296, 1268, 614, 1302, 3472, 6470, 6471, 3486, 3485, 6774,
-3714, 509, 508, 398, 1102, 4551, 4547, 4549, 6989, 6991, 6990,
-3715, 778, 1370, 769, 1372, 6993, 6992, 5474, 6994, 1626, 6473,
-3716, 870, 871, 350, 48, 1984, 6984, 6780, 6995, 6586, 4012,
-3717, 230, 799, 20, 161, 6996, 6779, 3688, 6785, 1803, 3575,
-3718, 399, 1102, 509, 398, 6997, 6989, 4550, 4195, 6990, 4549,
-3719, 230, 336, 953, 798, 4077, 6998, 5606, 6999, 7000, 2271,
-3720, 329, 971, 279, 816, 6977, 6869, 3962, 6119, 2325, 6121,
-3721, 716, 1278, 718, 1279, 7002, 7001, 5237, 7003, 3443, 7004,
-3722, 965, 809, 484, 964, 2306, 6318, 7005, 2308, 2304, 7006,
-3723, 891, 1047, 1046, 324, 2545, 2547, 2543, 6641, 7007, 6640,
-3724, 824, 48, 251, 49, 7009, 3746, 7008, 7010, 1572, 3747,
-3725, 361, 1048, 892, 1047, 6868, 2548, 7011, 7012, 2550, 2546,
-3726, 506, 396, 1058, 395, 4541, 6918, 6766, 4540, 4186, 7013,
-3727, 341, 809, 28, 234, 6317, 7014, 3988, 4054, 6319, 3696,
-3728, 892, 1047, 891, 324, 2546, 2545, 2047, 7015, 7007, 6641,
-3729, 1277, 1345, 671, 713, 2697, 7016, 5560, 7017, 7018, 5299,
-3730, 669, 612, 1214, 1282, 5087, 7019, 6050, 6048, 7020, 3424,
-3731, 1365, 764, 1362, 1368, 6932, 6108, 1637, 1638, 6448, 1625,
-3732, 396, 250, 397, 906, 4185, 4187, 4189, 6546, 7021, 6545,
-3733, 966, 378, 967, 1095, 7023, 7022, 2314, 2733, 6295, 2735,
-3734, 273, 71, 1376, 70, 3813, 7025, 7024, 3812, 1594, 7026,
-3735, 889, 323, 359, 66, 6181, 4093, 5818, 5819, 3947, 4030,
-3736, 121, 927, 846, 291, 2129, 2131, 1920, 7027, 7029, 7028,
-3737, 493, 1093, 964, 377, 7031, 2726, 7030, 4506, 7033, 7032,
-3738, 242, 40, 902, 39, 3720, 7035, 7034, 3719, 1563, 7036,
-3739, 1288, 667, 1306, 1293, 6743, 6392, 3231, 3526, 6744, 3041,
-3740, 361, 70, 892, 893, 4034, 7037, 7011, 7038, 7039, 2050,
-3741, 823, 906, 47, 250, 2161, 7041, 7040, 7042, 7021, 3743,
-3742, 780, 775, 768, 1359, 5491, 5489, 5493, 6406, 6299, 6263,
-3743, 1271, 586, 1227, 652, 6685, 5610, 3385, 6698, 5028, 6702,
-3744, 500, 499, 1184, 609, 4523, 5682, 6843, 4887, 4886, 6661,
-3745, 386, 818, 240, 997, 7043, 6835, 4155, 7044, 2397, 6836,
-3746, 1298, 1303, 661, 1261, 3407, 7045, 6723, 3470, 3516, 6725,
-3747, 1101, 591, 517, 516, 6513, 4826, 5591, 6816, 4825, 4577,
-3748, 713, 1357, 766, 1333, 7047, 7046, 5420, 7048, 1693, 7049,
-3749, 814, 425, 969, 236, 5612, 7050, 2319, 5613, 4439, 7051,
-3750, 811, 810, 29, 235, 1841, 7053, 7052, 6039, 7054, 3699,
-3751, 1196, 1225, 1195, 644, 3199, 3356, 3313, 6082, 6083, 7055,
-3752, 1027, 871, 351, 314, 2485, 6589, 6567, 6980, 6621, 4061,
-3753, 918, 993, 420, 835, 2385, 6916, 7056, 2173, 2386, 7057,
-3754, 824, 906, 980, 251, 2193, 2350, 2349, 7008, 7059, 7058,
-3755, 1284, 686, 1221, 1259, 6570, 7060, 3442, 3446, 6289, 3358,
-3756, 1007, 442, 1068, 543, 7062, 7061, 2628, 7063, 4658, 6514,
-3757, 1102, 1113, 400, 510, 2925, 5739, 5737, 5659, 5660, 4553,
-3758, 336, 798, 160, 797, 7000, 1800, 7064, 7065, 1802, 1798,
-3759, 274, 918, 836, 993, 6670, 2205, 6668, 7066, 2385, 2387,
-3760, 987, 410, 409, 517, 5921, 4228, 5885, 5592, 4578, 4576,
-3761, 917, 70, 1376, 215, 7067, 7026, 6962, 2106, 7068, 6963,
-3762, 1376, 216, 918, 835, 7070, 2109, 7069, 6964, 1895, 2173,
-3763, 286, 431, 430, 843, 4290, 4292, 4288, 5882, 7071, 5881,
-3764, 275, 993, 1062, 421, 7073, 2604, 7072, 4260, 7074, 6064,
-3765, 275, 993, 836, 1062, 7073, 2387, 7075, 7072, 2604, 2603,
-3766, 1376, 215, 893, 216, 6963, 2048, 7076, 7070, 1452, 2049,
-3767, 616, 1207, 1076, 575, 5554, 3106, 7077, 5142, 7078, 5890,
-3768, 834, 69, 214, 68, 6211, 7079, 1893, 6271, 1592, 6783,
-3769, 704, 1306, 1288, 667, 6203, 3231, 6371, 5194, 6392, 6743,
-3770, 10, 787, 149, 225, 7080, 1767, 3553, 3678, 7081, 5575,
-3771, 789, 226, 944, 788, 7082, 6221, 2244, 1775, 6030, 2243,
-3772, 274, 993, 275, 421, 7066, 7073, 3820, 4259, 7074, 4260,
-3773, 155, 334, 793, 792, 6806, 6385, 1785, 1783, 7083, 1787,
-3774, 968, 1096, 529, 1097, 2738, 5661, 5810, 2740, 2742, 5722,
-3775, 528, 1095, 596, 1218, 7085, 7084, 4840, 6922, 3161, 6496,
-3776, 836, 993, 275, 274, 2387, 7073, 7075, 6668, 7066, 3820,
-3777, 438, 1004, 539, 437, 6953, 7086, 4646, 4313, 6839, 4645,
-3778, 539, 1004, 1000, 437, 7086, 2419, 7087, 4645, 6839, 6837,
-3779, 331, 786, 382, 225, 7089, 7088, 4144, 3991, 7090, 4143,
-3780, 1307, 1201, 605, 1267, 3504, 6532, 6770, 1735, 3463, 7091,
-3781, 348, 455, 1021, 311, 4365, 6663, 7092, 4058, 4366, 7093,
-3782, 1365, 776, 777, 1338, 7094, 5482, 6491, 1666, 7095, 6492,
-3783, 380, 1017, 1119, 1018, 7096, 2806, 5954, 7097, 2460, 2807,
-3784, 382, 786, 331, 941, 7088, 7089, 4144, 7098, 2235, 7099,
-3785, 953, 797, 336, 952, 2270, 7065, 6998, 2272, 2268, 6742,
-3786, 9, 225, 149, 786, 3679, 5575, 3550, 7100, 7090, 1765,
-3787, 450, 343, 1011, 306, 4440, 7102, 7101, 4348, 4356, 7103,
-3788, 165, 802, 22, 338, 1813, 7104, 3579, 6279, 7105, 3982,
-3789, 28, 809, 171, 234, 7014, 1833, 3593, 3696, 6319, 6160,
-3790, 37, 182, 181, 859, 6423, 1418, 7106, 5802, 1947, 1946,
-3791, 568, 1095, 584, 378, 5639, 5649, 4877, 4878, 6295, 4802,
-3792, 149, 148, 9, 786, 1384, 3551, 3550, 1765, 1764, 7100,
-3793, 275, 72, 836, 274, 3818, 6669, 7075, 3820, 3816, 6668,
-3794, 815, 814, 177, 32, 1853, 1849, 1851, 6605, 7107, 3601,
-3795, 484, 810, 965, 378, 7108, 2307, 7005, 4456, 7109, 6294,
-3796, 1151, 1049, 473, 1150, 2902, 6608, 7110, 2904, 2900, 7111,
-3797, 382, 786, 942, 225, 7088, 2237, 7112, 4143, 7090, 7113,
-3798, 991, 1103, 416, 1061, 2755, 7115, 7114, 2648, 2756, 7116,
-3799, 953, 336, 372, 952, 6998, 4123, 7117, 2272, 6742, 6740,
-3800, 942, 786, 382, 941, 2237, 7088, 7112, 2239, 2235, 7098,
-3801, 76, 838, 77, 279, 6824, 7118, 1600, 3830, 6823, 3831,
-3802, 177, 814, 176, 32, 1849, 1848, 1412, 3601, 7107, 3602,
-3803, 219, 220, 75, 837, 1456, 7120, 7119, 1900, 1899, 7121,
-3804, 78, 839, 108, 280, 6505, 1905, 3609, 3834, 6353, 6635,
-3805, 341, 809, 484, 810, 6317, 6318, 4453, 7122, 1838, 7108,
-3806, 689, 589, 1253, 588, 5154, 7124, 7123, 5153, 4818, 7125,
-3807, 920, 970, 425, 424, 2916, 6818, 5893, 5626, 5896, 4274,
-3808, 1292, 608, 1197, 586, 6058, 6012, 3455, 6686, 4885, 5657,
-3809, 1166, 1170, 540, 1004, 2977, 7126, 5704, 2955, 2975, 6951,
-3810, 670, 1315, 712, 1304, 6055, 7127, 5217, 7128, 1740, 7129,
-3811, 41, 310, 347, 864, 3920, 4057, 4007, 7130, 5642, 5793,
-3812, 540, 1170, 539, 1004, 7126, 7131, 4650, 6951, 2975, 7086,
-3813, 416, 270, 991, 1061, 4245, 7132, 7114, 7116, 7133, 2648,
-3814, 18, 797, 160, 159, 6591, 1798, 3570, 3571, 1797, 1395,
-3815, 160, 797, 18, 336, 1798, 6591, 3570, 7064, 7065, 3978,
-3816, 550, 1137, 1231, 1200, 7135, 3226, 7134, 7136, 3228, 3229,
-3817, 483, 1093, 493, 377, 7137, 7031, 4507, 4501, 7033, 4506,
-3818, 27, 808, 340, 234, 6323, 6776, 3985, 3697, 6324, 4081,
-3819, 880, 58, 319, 355, 5596, 3939, 5594, 6325, 4022, 4089,
-3820, 60, 882, 320, 883, 6733, 7138, 3941, 6650, 2020, 6673,
-3821, 963, 1093, 483, 377, 2724, 7137, 7139, 7140, 7033, 4501,
-3822, 808, 377, 484, 964, 6777, 4455, 7141, 2303, 7032, 7006,
-3823, 1325, 1336, 759, 719, 3271, 7143, 7142, 6736, 7144, 5392,
-3824, 242, 39, 902, 819, 3719, 7036, 7034, 7145, 7146, 2220,
-3825, 1145, 1043, 1044, 470, 2884, 2538, 2885, 6431, 6715, 7147,
-3826, 521, 520, 1182, 629, 4591, 6363, 7148, 4944, 4943, 7149,
-3827, 1221, 631, 525, 524, 7151, 4834, 7150, 7152, 4948, 4603,
-3828, 1221, 524, 1110, 1219, 7152, 5936, 3180, 3181, 7153, 3165,
-3829, 976, 819, 241, 974, 2337, 6149, 6077, 2339, 2333, 6201,
-3830, 424, 994, 423, 277, 5628, 6689, 4270, 4268, 7154, 4266,
-3831, 111, 81, 282, 283, 3615, 3840, 7155, 7156, 3842, 3844,
-3832, 241, 819, 242, 974, 6149, 7145, 3721, 6201, 2333, 5677,
-3833, 285, 842, 284, 83, 7157, 6955, 3850, 3848, 7158, 3846,
-3834, 935, 1009, 447, 853, 2430, 5724, 7159, 2188, 2431, 5725,
-3835, 100, 101, 302, 135, 1550, 3900, 3899, 3658, 3659, 7160,
-3836, 119, 845, 88, 289, 1918, 7161, 3630, 7162, 7163, 3861,
-3837, 548, 447, 448, 1009, 4673, 4343, 4674, 5664, 5724, 5663,
-3838, 110, 840, 922, 282, 1907, 2221, 2120, 7164, 7166, 7165,
-3839, 242, 819, 902, 974, 7145, 2220, 7034, 5677, 2333, 2332,
-3840, 436, 292, 846, 291, 4306, 7168, 7167, 4305, 3871, 7028,
-3841, 426, 569, 1154, 972, 4738, 5789, 7169, 7170, 7171, 2915,
-3842, 582, 1225, 617, 1226, 6194, 6628, 5023, 6809, 3256, 6808,
-3843, 444, 1008, 933, 445, 5768, 2429, 5766, 4334, 7173, 7172,
-3844, 443, 850, 1007, 442, 6936, 2427, 7174, 4328, 6940, 7062,
-3845, 264, 830, 206, 913, 6935, 1885, 6934, 6712, 2168, 2099,
-3846, 1065, 435, 1054, 927, 6421, 7175, 2615, 2616, 6456, 2569,
-3847, 704, 666, 1288, 1320, 5197, 6746, 6371, 6372, 7176, 3233,
-3848, 1000, 436, 437, 928, 7177, 4310, 6837, 2407, 7179, 7178,
-3849, 539, 438, 540, 1004, 4646, 4648, 4650, 7086, 6953, 6951,
-3850, 308, 456, 452, 1015, 4367, 4370, 4355, 6558, 6117, 5534,
-3851, 853, 101, 136, 135, 7180, 3660, 1933, 1934, 3659, 1489,
-3852, 1172, 641, 545, 544, 7181, 4982, 6253, 7182, 4980, 4666,
-3853, 682, 737, 1332, 733, 5319, 7183, 5869, 5303, 5385, 7184,
-3854, 1007, 850, 1068, 442, 2427, 2626, 2628, 7062, 6940, 7061,
-3855, 987, 830, 264, 913, 2370, 6935, 7185, 2369, 2168, 6712,
-3856, 77, 838, 221, 222, 7118, 1902, 7186, 6162, 1901, 1458,
-3857, 331, 784, 940, 785, 5668, 2231, 5772, 5669, 1763, 2232,
-3858, 809, 808, 171, 234, 1835, 1831, 1833, 6319, 6324, 6160,
-3859, 76, 898, 364, 328, 5846, 5842, 4040, 3957, 5845, 4098,
-3860, 408, 1105, 986, 1060, 6706, 2760, 6948, 5813, 2759, 2595,
-3861, 1375, 34, 78, 1, 6506, 3833, 6504, 7187, 1557, 1527,
-3862, 1078, 570, 1077, 368, 5584, 7188, 2674, 5585, 4742, 5743,
-3863, 936, 305, 449, 1010, 7189, 4345, 6617, 2432, 7190, 5808,
-3864, 383, 1076, 1077, 944, 5904, 2671, 7191, 5701, 2667, 2669,
-3865, 923, 841, 428, 284, 2176, 5711, 5764, 5765, 5712, 4282,
-3866, 999, 365, 1005, 1014, 5898, 5899, 2610, 2792, 7192, 2643,
-3867, 456, 365, 999, 1014, 4369, 5898, 7193, 6116, 7192, 2792,
-3868, 1005, 365, 345, 1014, 5899, 4109, 6576, 2643, 7192, 7194,
-3869, 231, 164, 22, 21, 7195, 3580, 3690, 3691, 3578, 1514,
-3870, 1209, 598, 1210, 610, 6390, 6388, 3120, 5618, 4889, 7196,
-3871, 836, 73, 218, 72, 7197, 6097, 1897, 6669, 1596, 7198,
-3872, 381, 1027, 314, 1026, 7199, 6980, 4141, 7200, 2487, 6981,
-3873, 275, 73, 836, 72, 3819, 7197, 7075, 3818, 1596, 6669,
-3874, 804, 805, 339, 167, 1823, 5496, 5615, 1819, 1821, 6759,
-3875, 955, 1085, 373, 1086, 2700, 5621, 5914, 2702, 2704, 7201,
-3876, 264, 913, 265, 988, 6712, 6713, 3790, 6898, 2372, 6897,
-3877, 381, 314, 350, 1026, 4141, 4084, 4142, 7200, 6981, 7202,
-3878, 931, 442, 1068, 850, 7203, 7061, 2624, 2212, 6940, 2626,
-3879, 21, 800, 162, 337, 7204, 1806, 3577, 3979, 5966, 6778,
-3880, 21, 162, 20, 337, 3577, 3574, 1513, 3979, 6778, 3980,
-3881, 449, 305, 450, 1010, 4345, 4347, 4349, 5808, 7190, 6433,
-3882, 100, 135, 934, 134, 3658, 2144, 7205, 3657, 1488, 2145,
-3883, 1265, 1327, 1273, 752, 3448, 3170, 3393, 6394, 7206, 6901,
-3884, 1253, 1193, 1239, 589, 3327, 3275, 3328, 7124, 7208, 7207,
-3885, 903, 821, 187, 42, 2155, 1868, 2078, 6655, 7210, 7209,
-3886, 441, 442, 1068, 931, 4325, 7061, 6222, 5564, 7203, 2624,
-3887, 1121, 1020, 1122, 458, 2813, 2815, 2817, 7211, 6086, 6301,
-3888, 309, 453, 380, 1017, 4358, 4361, 4140, 7212, 7213, 7096,
-3889, 353, 1032, 463, 489, 7214, 5946, 4392, 4479, 5948, 4480,
-3890, 100, 301, 934, 302, 3897, 7215, 7205, 3899, 3901, 7216,
-3891, 991, 270, 271, 916, 7132, 3808, 7217, 2381, 6196, 7218,
-3892, 473, 558, 474, 1152, 4698, 4697, 4493, 7219, 7220, 6597,
-3893, 837, 994, 424, 277, 2388, 5628, 6332, 7221, 7154, 4268,
-3894, 301, 852, 133, 134, 7223, 1932, 7222, 7224, 1931, 1487,
-3895, 1263, 585, 1175, 1207, 6358, 7225, 3376, 3396, 5906, 3107,
-3896, 934, 301, 446, 302, 7215, 4335, 7226, 7216, 3901, 4336,
-3897, 1360, 1355, 736, 1371, 1644, 6512, 5978, 1645, 1608, 6667,
-3898, 187, 821, 188, 42, 1868, 1867, 1424, 7209, 7210, 5779,
-3899, 617, 608, 1264, 654, 4910, 6011, 7227, 5039, 5038, 7228,
-3900, 1089, 959, 1090, 494, 2712, 2714, 2716, 7229, 5531, 5530,
-3901, 1097, 970, 920, 424, 2917, 2916, 2784, 5627, 5896, 5626,
-3902, 402, 1059, 909, 983, 7231, 2592, 7230, 7232, 2646, 2359,
-3903, 968, 813, 342, 812, 2316, 5916, 5915, 2315, 1847, 6722,
-3904, 670, 654, 712, 1315, 5089, 5218, 5217, 6055, 7233, 7127,
-3905, 781, 899, 77, 328, 2152, 6062, 6045, 6047, 5848, 3956,
-3906, 356, 1037, 319, 466, 7235, 7234, 4066, 4402, 7236, 4400,
-3907, 67, 889, 66, 323, 7237, 5819, 1590, 3946, 6181, 3947,
-3908, 1123, 1021, 1022, 455, 2818, 2472, 2819, 5748, 6663, 5747,
-3909, 41, 310, 864, 863, 3920, 5642, 7130, 7238, 5643, 1963,
-3910, 833, 269, 268, 990, 6805, 3802, 6830, 2379, 7239, 6831,
-3911, 1271, 619, 714, 652, 6950, 5222, 7240, 6698, 5029, 5223,
-3912, 231, 481, 374, 957, 4446, 4495, 4128, 7241, 7242, 6646,
-3913, 67, 323, 890, 889, 3946, 7244, 7243, 7237, 6181, 2041,
-3914, 470, 359, 1044, 323, 4411, 6483, 7147, 4413, 4093, 6178,
-3915, 779, 1369, 1371, 1367, 7245, 1631, 6525, 6538, 1629, 1632,
-3916, 890, 323, 67, 360, 7244, 3946, 7243, 7246, 4070, 4033,
-3917, 889, 1044, 359, 323, 2537, 6483, 5818, 6181, 6178, 4093,
-3918, 228, 794, 371, 335, 5959, 7247, 4122, 4048, 5961, 4121,
-3919, 401, 826, 402, 1059, 5991, 7248, 4204, 5993, 2590, 7231,
-3920, 698, 618, 1272, 685, 5177, 6904, 5777, 5176, 5136, 7249,
-3921, 1373, 59, 882, 204, 6927, 6928, 6731, 7250, 7251, 2015,
-3922, 1200, 604, 550, 614, 7252, 4869, 7136, 6469, 5005, 4900,
-3923, 698, 1307, 658, 677, 5775, 5774, 5273, 5274, 7253, 5109,
-3924, 346, 863, 1018, 310, 7255, 2459, 7254, 4105, 5643, 7256,
-3925, 715, 675, 1321, 750, 5228, 5987, 7257, 5354, 5353, 7258,
-3926, 47, 192, 870, 193, 7259, 1979, 6781, 7260, 1429, 1980,
-3927, 275, 919, 836, 73, 7261, 2174, 7075, 3819, 6028, 7197,
-3928, 326, 1050, 1051, 895, 6691, 2559, 7262, 6683, 2555, 2557,
-3929, 381, 1127, 1128, 1026, 7264, 2835, 7263, 7200, 2831, 2833,
-3930, 451, 1019, 384, 310, 7265, 5950, 4353, 4350, 5641, 4151,
-3931, 474, 1050, 473, 1152, 6598, 7266, 4493, 6597, 2905, 7219,
-3932, 186, 863, 41, 864, 1959, 7238, 5751, 1961, 1963, 7130,
-3933, 374, 1088, 958, 957, 7267, 2709, 6000, 6646, 2708, 2287,
-3934, 1320, 666, 1288, 1275, 7176, 6746, 3233, 3536, 6342, 3264,
-3935, 41, 863, 186, 40, 7238, 1959, 5751, 1564, 7268, 5901,
-3936, 197, 874, 52, 875, 1992, 6874, 7269, 1994, 1996, 6875,
-3937, 924, 285, 286, 84, 6771, 3853, 5883, 6956, 3849, 3851,
-3938, 874, 52, 316, 352, 6874, 3933, 6873, 7270, 4016, 4086,
-3939, 190, 46, 45, 905, 7271, 1569, 6775, 2083, 6462, 6657,
-3940, 934, 446, 447, 302, 7226, 4340, 7272, 7216, 4336, 4338,
-3941, 505, 1239, 1193, 589, 6313, 3275, 6091, 4817, 7207, 7208,
-3942, 196, 874, 52, 197, 1991, 6874, 7273, 1433, 1992, 7269,
-3943, 196, 197, 52, 908, 1433, 7269, 7273, 2089, 2088, 7274,
-3944, 639, 542, 1099, 541, 4974, 7275, 6041, 4973, 4656, 6665,
-3945, 700, 710, 1256, 1289, 5312, 7277, 7276, 7278, 7279, 3449,
-3946, 52, 51, 352, 874, 1575, 4017, 4016, 6874, 7280, 7270,
-3947, 314, 871, 350, 1026, 6621, 6984, 4084, 6981, 2483, 7202,
-3948, 62, 357, 885, 884, 4026, 7282, 7281, 7283, 6652, 2026,
-3949, 722, 1347, 731, 728, 7285, 7284, 5294, 5279, 7286, 5372,
-3950, 780, 777, 1329, 1359, 5488, 7288, 7287, 6406, 6493, 1677,
-3951, 357, 62, 885, 321, 4026, 7281, 7282, 4091, 3943, 7289,
-3952, 1154, 972, 999, 426, 2915, 2405, 2914, 7169, 7170, 7290,
-3953, 768, 764, 1365, 1368, 5429, 6932, 6265, 6264, 6448, 1638,
-3954, 63, 885, 62, 321, 7291, 7281, 1586, 3942, 7289, 3943,
-3955, 42, 311, 865, 347, 3923, 7292, 5781, 4006, 4102, 5791,
-3956, 284, 112, 923, 841, 7293, 2122, 5765, 5712, 1909, 2176,
-3957, 950, 496, 479, 951, 6891, 4512, 7294, 2266, 7296, 7295,
-3958, 881, 1037, 356, 882, 2515, 7235, 7297, 2017, 2516, 7298,
-3959, 1138, 487, 1137, 1036, 6412, 7299, 2865, 2863, 5506, 2861,
-3960, 174, 235, 812, 811, 6147, 7300, 1842, 1840, 6039, 1844,
-3961, 21, 801, 164, 163, 7301, 1810, 3578, 3576, 1809, 1399,
-3962, 945, 368, 1078, 1077, 5744, 5585, 2672, 2670, 5743, 2674,
-3963, 1342, 751, 1339, 1366, 7302, 6913, 1665, 1662, 6416, 1664,
-3964, 493, 596, 568, 1094, 4906, 4905, 4735, 7303, 5527, 5640,
-3965, 219, 896, 327, 897, 2058, 7305, 7304, 2060, 2062, 7306,
-3966, 219, 896, 74, 327, 2058, 7308, 7307, 7304, 7305, 3955,
-3967, 243, 820, 41, 244, 6154, 5753, 3723, 3727, 6529, 3725,
-3968, 679, 1256, 1240, 1237, 6853, 3349, 7309, 7310, 3339, 3279,
-3969, 768, 776, 1365, 1351, 5462, 7094, 6265, 7311, 7312, 1648,
-3970, 896, 1052, 327, 897, 2560, 5940, 7305, 2062, 2561, 7306,
-3971, 1090, 1215, 583, 571, 3146, 6561, 6216, 7313, 6841, 4799,
-3972, 512, 1104, 1116, 983, 7314, 2799, 6459, 7315, 2758, 2797,
-3973, 74, 896, 363, 327, 7308, 7316, 4038, 3955, 7305, 4097,
-3974, 482, 338, 802, 803, 4449, 7105, 7317, 6164, 6280, 1817,
-3975, 1184, 499, 601, 609, 5682, 4857, 5680, 6661, 4886, 4888,
-3976, 909, 983, 403, 402, 2359, 6478, 6647, 7230, 7232, 4207,
-3977, 459, 1126, 567, 1127, 7319, 7318, 4731, 7320, 2832, 7321,
-3978, 219, 73, 74, 896, 6098, 1597, 7307, 2058, 7322, 7308,
-3979, 1199, 1230, 647, 555, 3076, 6560, 6559, 7323, 7324, 4999,
-3980, 1174, 1181, 590, 1116, 3015, 5577, 6457, 2993, 3013, 6281,
-3981, 74, 73, 363, 896, 1597, 4039, 4038, 7308, 7322, 7316,
-3982, 194, 49, 824, 907, 7325, 7010, 1873, 2087, 7326, 2162,
-3983, 1033, 1032, 317, 489, 2505, 7328, 7327, 7329, 5948, 4481,
-3984, 50, 907, 194, 195, 7331, 2087, 7330, 6626, 2086, 1431,
-3985, 50, 907, 252, 49, 7331, 6761, 3750, 1573, 7326, 3749,
-3986, 49, 252, 824, 907, 3749, 7332, 7010, 7326, 6761, 2162,
-3987, 252, 49, 824, 251, 3749, 7010, 7332, 3751, 3747, 7008,
-3988, 990, 414, 267, 832, 6019, 4238, 7333, 2378, 5859, 5549,
-3989, 1089, 1088, 958, 494, 2713, 2709, 2711, 7229, 7334, 6002,
-3990, 279, 838, 77, 816, 6823, 7118, 3831, 6121, 1903, 6120,
-3991, 372, 952, 229, 479, 6740, 6741, 4124, 4499, 7335, 4442,
-3992, 22, 802, 231, 338, 7104, 7336, 3690, 3982, 7105, 4051,
-3993, 1275, 666, 1288, 1274, 6342, 6746, 3264, 3263, 5762, 1746,
-3994, 485, 378, 584, 967, 4496, 4802, 4801, 7337, 7022, 5647,
-3995, 1376, 71, 918, 216, 7025, 7338, 7069, 7070, 5674, 2109,
-3996, 1376, 835, 918, 273, 6964, 2173, 7069, 7024, 7340, 7339,
-3997, 77, 222, 221, 899, 6162, 1458, 7186, 6062, 2067, 2066,
-3998, 969, 970, 424, 425, 2323, 5896, 5895, 7050, 6818, 4274,
-3999, 529, 379, 968, 1097, 4727, 5812, 5810, 5722, 5794, 2740,
-4000, 935, 448, 447, 1009, 6123, 4343, 7159, 2430, 5663, 5724,
-4001, 435, 290, 1066, 434, 4302, 6453, 6454, 4304, 4300, 7341,
-4002, 273, 71, 274, 918, 3813, 3815, 3817, 7339, 7338, 6670,
-4003, 240, 818, 386, 239, 6835, 7043, 4155, 3715, 7342, 4154,
-4004, 130, 932, 298, 850, 2141, 5740, 7343, 1927, 2185, 5833,
-4005, 956, 800, 801, 481, 2279, 1811, 2280, 5623, 5873, 5872,
-4006, 968, 379, 969, 1097, 5812, 7344, 2320, 2740, 5794, 2741,
-4007, 1107, 1179, 622, 1193, 3027, 7345, 6018, 3051, 3176, 7346,
-4008, 425, 379, 969, 236, 4460, 7344, 7050, 4439, 4137, 7051,
-4009, 1134, 1032, 1033, 489, 2851, 2505, 2852, 5958, 5948, 7329,
-4010, 1054, 436, 846, 435, 7347, 7167, 2568, 7175, 4307, 7348,
-4011, 1063, 534, 535, 431, 7349, 4633, 5910, 5912, 4629, 4631,
-4012, 918, 835, 420, 273, 2173, 7057, 7056, 7339, 7340, 4256,
-4013, 1161, 574, 1189, 531, 5957, 5955, 3038, 6230, 4803, 6229,
-4014, 350, 871, 870, 1026, 6984, 1984, 6780, 7202, 2483, 2482,
-4015, 886, 885, 321, 1041, 2029, 7289, 7350, 2528, 2527, 7351,
-4016, 466, 1037, 319, 1036, 7236, 7234, 4400, 7352, 2517, 7353,
-4017, 1144, 1043, 1145, 486, 2882, 2884, 2886, 7354, 6716, 6432,
-4018, 846, 292, 122, 291, 7168, 7355, 1919, 7028, 3871, 7356,
-4019, 317, 1032, 353, 489, 7328, 7214, 4087, 4481, 5948, 4479,
-4020, 525, 1108, 1110, 992, 7358, 2776, 7357, 7359, 2769, 2773,
-4021, 601, 643, 1249, 609, 4989, 7361, 7360, 4888, 5072, 6884,
-4022, 1331, 698, 703, 721, 6582, 5192, 6942, 6554, 5249, 5248,
-4023, 1266, 1247, 656, 720, 3375, 5786, 5785, 7362, 6234, 5245,
-4024, 36, 900, 818, 239, 5569, 2219, 7363, 3710, 5567, 7342,
-4025, 726, 700, 689, 1289, 5271, 5193, 5272, 7364, 7278, 7365,
-4026, 439, 929, 438, 294, 7367, 7366, 4316, 4314, 6937, 4312,
-4027, 537, 1054, 538, 635, 7368, 6311, 4643, 4961, 6304, 4962,
-4028, 848, 929, 439, 294, 2210, 7367, 7369, 7370, 6937, 4314,
-4029, 546, 1069, 446, 1070, 5735, 7371, 4668, 6871, 2652, 6872,
-4030, 1250, 643, 1249, 1169, 7372, 7361, 3348, 3293, 6258, 3316,
-4031, 1000, 436, 538, 437, 7177, 4642, 7373, 6837, 4310, 4644,
-4032, 547, 643, 546, 1169, 4987, 4986, 4672, 6257, 6258, 6300,
-4033, 438, 293, 294, 929, 4311, 3877, 4312, 7366, 7374, 6937,
-4034, 601, 643, 1165, 1249, 4989, 6075, 6076, 7360, 7361, 3315,
-4035, 1184, 609, 1249, 1269, 6661, 6884, 3337, 3381, 6885, 3413,
-4036, 1254, 1289, 1253, 688, 3451, 3457, 3333, 7375, 7377, 7376,
-4037, 748, 734, 1255, 1252, 5369, 7379, 7378, 6784, 6246, 3336,
-4038, 550, 1137, 1200, 1138, 7135, 3228, 7136, 6411, 2865, 3079,
-4039, 901, 240, 241, 38, 6834, 3718, 6148, 6163, 3714, 3716,
-4040, 447, 1070, 547, 446, 5726, 5731, 4671, 4340, 6872, 4670,
-4041, 1298, 645, 1285, 1261, 6724, 5539, 3469, 3470, 5541, 3435,
-4042, 847, 293, 438, 929, 7381, 4311, 7380, 2182, 7374, 7366,
-4043, 1056, 391, 503, 392, 7383, 4530, 7382, 7384, 4174, 4531,
-4044, 1231, 1136, 553, 1135, 3078, 7386, 7385, 3077, 2859, 7387,
-4045, 1319, 724, 702, 742, 7388, 5263, 6005, 6466, 5329, 5328,
-4046, 109, 80, 281, 840, 3612, 3837, 7389, 1908, 7390, 5696,
-4047, 199, 256, 909, 827, 6407, 6648, 2090, 1880, 6408, 2196,
-4048, 391, 973, 1056, 1114, 7391, 2577, 7383, 5862, 2789, 2791,
-4049, 955, 1086, 373, 481, 2702, 7201, 5914, 5624, 5625, 4461,
-4050, 957, 802, 231, 801, 2283, 7336, 7241, 2282, 1814, 5870,
-4051, 1196, 1118, 574, 1206, 3061, 7393, 7392, 3175, 3103, 5956,
-4052, 331, 148, 147, 785, 7394, 1383, 5667, 5669, 1762, 1761,
-4053, 357, 884, 1040, 885, 6652, 2524, 7395, 7282, 2026, 2525,
-4054, 961, 1092, 483, 962, 2720, 7397, 7396, 2299, 2721, 7398,
-4055, 358, 886, 1041, 1042, 6187, 2528, 7399, 7400, 2530, 2532,
-4056, 892, 324, 361, 1047, 7015, 4071, 7011, 2546, 7007, 7012,
-4057, 1196, 644, 1189, 574, 6082, 6548, 3314, 7392, 4992, 5955,
-4058, 602, 486, 1144, 576, 4859, 7354, 7401, 4861, 4769, 5599,
-4059, 814, 32, 815, 329, 7107, 6605, 1853, 5611, 3961, 6122,
-4060, 989, 413, 1055, 832, 7402, 5858, 2574, 2376, 5547, 2573,
-4061, 174, 811, 29, 235, 1840, 7052, 3596, 6147, 6039, 3699,
-4062, 358, 1042, 1041, 469, 7400, 2532, 7399, 4407, 6029, 6015,
-4063, 987, 410, 264, 830, 5921, 4227, 7185, 2370, 5922, 6935,
-4064, 1233, 557, 1144, 602, 6632, 7403, 3237, 7404, 4860, 7401,
-4065, 239, 1072, 900, 818, 7405, 2640, 5567, 7342, 2639, 2219,
-4066, 42, 865, 187, 864, 5781, 1964, 7209, 5792, 1966, 1962,
-4067, 940, 563, 382, 941, 5645, 4716, 7406, 2236, 7407, 7098,
-4068, 382, 940, 331, 478, 7406, 5772, 4144, 4438, 5773, 4435,
-4069, 1299, 740, 1277, 674, 7409, 7408, 3397, 7410, 5220, 5561,
-4070, 468, 1040, 1041, 321, 7411, 2529, 6881, 4405, 7412, 7351,
-4071, 331, 940, 382, 941, 5772, 7406, 4144, 7099, 2236, 7098,
-4072, 407, 406, 1057, 515, 4219, 6395, 7413, 4570, 4569, 7414,
-4073, 1144, 557, 1233, 1143, 7403, 6632, 3237, 2883, 6886, 3236,
-4074, 479, 496, 1083, 951, 4512, 6339, 7415, 7295, 7296, 2690,
-4075, 953, 798, 336, 797, 2271, 7000, 6998, 2270, 1802, 7065,
-4076, 952, 1083, 372, 1084, 2691, 7416, 6740, 2693, 2695, 7417,
-4077, 843, 1063, 925, 431, 2607, 2609, 2178, 7071, 5912, 5875,
-4078, 479, 951, 1083, 952, 7295, 2690, 7415, 7335, 2269, 2691,
-4079, 335, 794, 371, 795, 5961, 7247, 4121, 6232, 1793, 6286,
-4080, 692, 1251, 691, 622, 7419, 7418, 5289, 5162, 7420, 5161,
-4081, 559, 1200, 1139, 550, 6866, 3080, 6929, 4702, 7136, 7421,
-4082, 881, 59, 204, 882, 7422, 7251, 2013, 2017, 6928, 2015,
-4083, 407, 986, 408, 1105, 6947, 6948, 4222, 7423, 2760, 6706,
-4084, 479, 795, 371, 950, 6285, 6286, 4466, 7294, 2262, 6890,
-4085, 1373, 912, 830, 262, 6376, 2199, 6374, 7424, 7425, 5913,
-4086, 518, 987, 1101, 517, 5827, 2750, 5826, 4581, 5592, 5591,
-4087, 694, 695, 724, 1311, 5266, 5360, 5264, 5985, 5687, 5686,
-4088, 1363, 1370, 778, 1372, 1605, 6993, 7426, 1630, 1626, 6994,
-4089, 1185, 520, 1109, 519, 6361, 6362, 3025, 7427, 4587, 6524,
-4090, 67, 68, 890, 360, 1591, 7428, 7243, 4033, 4032, 7246,
-4091, 473, 554, 1151, 1150, 4688, 7429, 7110, 7111, 7430, 2904,
-4092, 472, 1047, 1148, 1149, 7432, 2894, 7431, 7433, 2896, 2898,
-4093, 570, 610, 1209, 1208, 4890, 5618, 7434, 7435, 5619, 3117,
-4094, 1373, 204, 882, 205, 7250, 2015, 6731, 6375, 1441, 2016,
-4095, 549, 1083, 1177, 1084, 6337, 3001, 7436, 7437, 2695, 3002,
-4096, 1149, 1048, 472, 1047, 2897, 6675, 7433, 2896, 2550, 7432,
-4097, 1116, 1059, 401, 512, 2798, 5993, 7438, 6459, 7439, 4558,
-4098, 479, 952, 1083, 372, 7335, 2691, 7415, 4499, 6740, 7416,
-4099, 377, 808, 484, 234, 6777, 7141, 4455, 4133, 6324, 4454,
-4100, 1020, 864, 865, 347, 2464, 1966, 2465, 6087, 5793, 5791,
-4101, 964, 1093, 493, 1094, 2726, 7031, 7030, 2729, 2731, 7303,
-4102, 549, 581, 1177, 651, 4797, 5510, 7436, 5019, 5021, 7440,
-4103, 1116, 1059, 512, 983, 2798, 7439, 6459, 2797, 2646, 7315,
-4104, 1175, 1205, 603, 558, 3189, 7441, 6219, 7442, 7443, 4864,
-4105, 512, 1059, 402, 983, 7439, 7231, 4559, 7315, 2646, 7232,
-4106, 1116, 1113, 401, 1059, 2944, 7444, 7438, 2798, 2787, 5993,
-4107, 416, 1103, 523, 522, 7115, 6601, 4595, 4593, 6157, 4597,
-4108, 402, 1059, 512, 401, 7231, 7439, 4559, 4204, 5993, 4558,
-4109, 982, 401, 1113, 1059, 5992, 7444, 2788, 2591, 5993, 2787,
-4110, 41, 820, 903, 244, 5753, 2158, 5752, 3725, 6529, 6213,
-4111, 881, 882, 356, 59, 2017, 7298, 7297, 7422, 6928, 4025,
-4112, 259, 258, 910, 985, 3772, 6373, 6348, 6111, 7445, 2363,
-4113, 263, 61, 206, 60, 3783, 6680, 5690, 3782, 1584, 5689,
-4114, 67, 211, 889, 212, 7446, 2036, 7237, 6801, 1448, 2037,
-4115, 605, 602, 1233, 1307, 4872, 7404, 6631, 6770, 7447, 3505,
-4116, 990, 414, 415, 268, 6019, 4243, 5517, 6831, 4239, 4241,
-4117, 887, 888, 359, 65, 2035, 5820, 7448, 7449, 7450, 4031,
-4118, 1021, 311, 1020, 865, 7093, 6088, 2469, 2467, 7292, 2465,
-4119, 373, 565, 481, 1086, 4722, 4721, 4461, 7201, 6378, 5625,
-4120, 318, 355, 1035, 465, 4065, 5503, 7451, 4396, 4399, 7452,
-4121, 392, 973, 1056, 391, 7453, 2577, 7384, 4174, 7391, 7383,
-4122, 735, 719, 1295, 697, 5402, 7455, 7454, 5398, 5242, 7456,
-4123, 759, 1336, 735, 719, 7143, 7457, 5456, 5392, 7144, 5402,
-4124, 822, 978, 246, 904, 2346, 7459, 7458, 2191, 2441, 7460,
-4125, 812, 235, 967, 811, 7300, 6038, 2313, 1844, 6039, 2312,
-4126, 616, 610, 570, 1208, 4909, 4890, 4907, 5553, 5619, 7435,
-4127, 978, 822, 246, 247, 2346, 7458, 7459, 7461, 6659, 3736,
-4128, 295, 93, 930, 848, 3878, 7463, 7462, 7464, 7465, 2183,
-4129, 731, 1287, 1304, 1337, 6930, 3267, 6924, 7466, 2653, 2982,
-4130, 1102, 510, 400, 399, 5659, 4553, 5737, 6997, 4552, 4198,
-4131, 537, 634, 1112, 635, 4959, 7468, 7467, 4961, 4963, 5926,
-4132, 733, 774, 737, 1349, 5449, 5448, 5385, 7469, 7471, 7470,
-4133, 1223, 1174, 513, 1104, 3191, 7472, 5543, 3187, 2992, 5544,
-4134, 1002, 844, 432, 433, 2413, 7473, 5837, 5816, 7474, 4298,
-4135, 984, 404, 403, 513, 5499, 4210, 6476, 7475, 4563, 4562,
-4136, 510, 1113, 511, 1181, 5660, 5514, 4557, 6400, 3014, 5515,
-4137, 540, 1166, 638, 637, 5704, 5863, 4970, 4968, 5878, 4972,
-4138, 1065, 536, 1155, 634, 7476, 6354, 2918, 7477, 4958, 7478,
-4139, 1155, 634, 1112, 1065, 7478, 7468, 2920, 2918, 7477, 2783,
-4140, 612, 669, 1214, 583, 5087, 6050, 7019, 5003, 5085, 6218,
-4141, 444, 445, 933, 300, 4334, 7172, 5766, 4330, 4332, 7479,
-4142, 1242, 1181, 624, 590, 3285, 5576, 7480, 7481, 5577, 5058,
-4143, 1172, 641, 1237, 642, 7181, 5571, 3324, 6254, 4985, 5572,
-4144, 623, 510, 624, 1181, 4926, 4928, 4930, 6846, 6400, 5576,
-4145, 590, 511, 512, 1116, 4821, 4560, 4822, 6281, 5513, 6459,
-4146, 231, 802, 374, 338, 7336, 6645, 4128, 4051, 7105, 4127,
-4147, 534, 995, 1098, 533, 7482, 2745, 6502, 4630, 7483, 6903,
-4148, 1098, 995, 998, 533, 2745, 2606, 2743, 6903, 7483, 7484,
-4149, 430, 431, 534, 995, 4292, 4629, 4628, 7485, 7486, 7482,
-4150, 430, 995, 924, 843, 7485, 2392, 5884, 5881, 2391, 2207,
-4151, 430, 995, 534, 533, 7485, 7482, 4628, 4626, 7483, 4630,
-4152, 404, 405, 985, 258, 4213, 6109, 5497, 4209, 4211, 7445,
-4153, 886, 1041, 321, 358, 2528, 7351, 7350, 6187, 7399, 4068,
-4154, 469, 468, 1041, 321, 4409, 6881, 6015, 4408, 4405, 7351,
-4155, 357, 885, 1040, 321, 7282, 2525, 7395, 4091, 7289, 7412,
-4156, 775, 1368, 1359, 1358, 6267, 1658, 6299, 6268, 1656, 1659,
-4157, 998, 995, 430, 533, 2606, 7485, 7487, 7484, 7483, 4626,
-4158, 615, 1217, 595, 596, 5526, 6749, 5138, 5033, 5528, 4841,
-4159, 1245, 515, 1105, 1187, 7489, 7488, 3296, 3297, 7490, 3032,
-4160, 595, 1217, 1218, 596, 6749, 3162, 6495, 4841, 5528, 6496,
-4161, 440, 849, 441, 1006, 6907, 6908, 4322, 7491, 2425, 6224,
-4162, 1339, 699, 701, 751, 6542, 5244, 6911, 6913, 5358, 5357,
-4163, 881, 59, 356, 319, 7422, 4025, 7297, 5595, 3938, 4066,
-4164, 964, 377, 963, 808, 7032, 7140, 2305, 2303, 6777, 2301,
-4165, 353, 1032, 317, 877, 7214, 7328, 4087, 7492, 2501, 7493,
-4166, 1141, 556, 1142, 1201, 6726, 7494, 2877, 3234, 6534, 3084,
-4167, 1332, 737, 682, 715, 7183, 5319, 5869, 5868, 5318, 5285,
-4168, 639, 708, 1186, 709, 5210, 6070, 6517, 5211, 5213, 6151,
-4169, 1297, 689, 1253, 1289, 6595, 7123, 3467, 3192, 7365, 3457,
-4170, 56, 57, 828, 202, 1580, 6328, 6330, 7495, 6242, 1881,
-4171, 967, 378, 584, 1095, 7022, 4802, 5647, 2735, 6295, 5649,
-4172, 462, 555, 463, 1132, 4691, 4690, 4478, 7496, 5973, 5795,
-4173, 660, 579, 606, 1199, 5064, 4875, 5065, 6865, 6747, 6864,
-4174, 965, 378, 966, 1095, 6294, 7023, 2311, 2732, 6295, 2733,
-4175, 1166, 1004, 540, 1003, 2955, 6951, 5704, 2954, 2420, 5706,
-4176, 692, 1251, 749, 691, 7419, 7497, 5349, 5289, 7418, 5348,
-4177, 153, 13, 154, 791, 3558, 3560, 1389, 1779, 5692, 1780,
-4178, 315, 1028, 461, 488, 5998, 6566, 4388, 4474, 5999, 4475,
-4179, 934, 853, 447, 1070, 2215, 5725, 7272, 2633, 2632, 5726,
-4180, 1006, 1003, 440, 849, 2579, 7498, 7491, 2425, 2580, 6907,
-4181, 791, 13, 154, 227, 5692, 3560, 1780, 6101, 3683, 7499,
-4182, 1030, 874, 352, 1029, 2494, 7270, 5805, 2496, 2492, 7500,
-4183, 525, 420, 526, 1108, 4604, 4605, 4607, 7358, 6915, 5719,
-4184, 1131, 488, 462, 579, 7501, 4476, 5782, 6748, 4785, 4784,
-4185, 461, 1129, 492, 488, 6619, 7502, 4503, 4475, 7503, 4505,
-4186, 315, 488, 462, 1029, 4474, 4476, 4390, 5996, 5997, 5784,
-4187, 253, 399, 252, 981, 4194, 4193, 3754, 5758, 5759, 6721,
-4188, 891, 360, 1046, 890, 6642, 6643, 2543, 2044, 7246, 2542,
-4189, 1046, 360, 1045, 890, 6643, 7504, 2544, 2542, 7246, 2540,
-4190, 559, 1296, 648, 1201, 6867, 7505, 5007, 6021, 3464, 6533,
-4191, 309, 861, 1017, 862, 6145, 2455, 7212, 6159, 1957, 2456,
-4192, 562, 565, 649, 1087, 4723, 5012, 5011, 6131, 6379, 7506,
-4193, 516, 1245, 1101, 591, 7507, 3295, 6816, 4825, 7508, 6513,
-4194, 1312, 1334, 743, 1300, 3378, 6974, 7509, 3379, 3124, 6815,
-4195, 309, 346, 39, 862, 4056, 4005, 3918, 6159, 7510, 6158,
-4196, 461, 1028, 1129, 488, 6566, 2837, 6619, 4475, 5999, 7503,
-4197, 925, 1063, 1064, 432, 2609, 2613, 2612, 5876, 5911, 5839,
-4198, 1106, 1104, 513, 984, 2926, 5544, 5542, 2764, 2757, 7475,
-4199, 1298, 645, 659, 1285, 6724, 5062, 6788, 3469, 5539, 7511,
-4200, 53, 198, 197, 875, 6451, 1434, 6449, 7512, 1995, 1994,
-4201, 822, 247, 44, 246, 6659, 3734, 7513, 7458, 3736, 3732,
-4202, 826, 255, 198, 197, 6982, 6452, 1877, 1878, 6450, 1434,
-4203, 184, 38, 39, 861, 5924, 1562, 7514, 1953, 6146, 6144,
-4204, 2, 5, 143, 1374, 1497, 3542, 3539, 6604, 7515, 6603,
-4205, 154, 14, 227, 13, 3562, 3682, 7499, 3560, 1506, 3683,
-4206, 447, 446, 934, 1070, 4340, 7226, 7272, 5726, 6872, 2633,
-4207, 974, 388, 1100, 500, 5678, 7516, 2748, 6024, 4521, 7517,
-4208, 980, 1107, 397, 979, 2766, 6511, 6509, 2584, 2767, 6544,
-4209, 309, 344, 1016, 861, 4003, 5835, 7518, 6145, 6531, 2453,
-4210, 241, 388, 976, 974, 4160, 7519, 6077, 6201, 5678, 2339,
-4211, 495, 499, 601, 1183, 4764, 4857, 4856, 7520, 5683, 5681,
-4212, 593, 1258, 671, 1260, 7521, 6269, 5092, 7522, 3387, 5562,
-4213, 625, 1174, 1242, 590, 7524, 3284, 7523, 4933, 6457, 7481,
-4214, 345, 1014, 858, 1005, 7194, 2447, 6575, 6576, 2643, 2567,
-4215, 1094, 596, 615, 493, 5527, 5033, 5525, 7303, 4906, 4902,
-4216, 1033, 354, 317, 878, 7525, 4064, 7327, 2504, 7527, 7526,
-4217, 1129, 1028, 461, 1027, 2837, 6566, 6619, 2836, 2490, 6568,
-4218, 879, 354, 1034, 878, 7529, 7528, 2507, 2008, 7527, 2506,
-4219, 759, 718, 1325, 719, 5393, 6735, 7142, 5392, 5241, 6736,
-4220, 307, 365, 345, 1005, 4106, 4109, 4104, 5520, 5899, 6576,
-4221, 1167, 1069, 546, 1169, 2957, 5735, 5733, 3020, 2966, 6300,
-4222, 350, 1025, 459, 1026, 7531, 7530, 4378, 7202, 2484, 7532,
-4223, 612, 1214, 1282, 1215, 7019, 3424, 7020, 6842, 3148, 3425,
-4224, 1090, 494, 583, 1089, 5530, 4800, 6216, 2716, 7229, 6217,
-4225, 400, 1113, 511, 510, 5739, 5514, 4555, 4553, 5660, 4557,
-4226, 1195, 1225, 646, 644, 3356, 6627, 7533, 7055, 6083, 5022,
-4227, 1107, 1102, 509, 1179, 2927, 6989, 6971, 3027, 3007, 7534,
-4228, 351, 1027, 1028, 872, 6567, 2490, 6565, 6590, 2486, 2488,
-4229, 459, 1127, 381, 1026, 7320, 7264, 4381, 7532, 2831, 7200,
-4230, 351, 314, 461, 1027, 4061, 4386, 4385, 6567, 6980, 6568,
-4231, 381, 1027, 461, 314, 7199, 6568, 4387, 4141, 6980, 4386,
-4232, 605, 557, 1233, 602, 4870, 6632, 6631, 4872, 4860, 7404,
-4233, 606, 687, 1286, 619, 5143, 6069, 6067, 4916, 5144, 6946,
-4234, 1086, 956, 562, 481, 2703, 6917, 6377, 5625, 5623, 4712,
-4235, 546, 1069, 1070, 1169, 5735, 2652, 6871, 6300, 2966, 2965,
-4236, 1107, 1193, 622, 621, 3051, 7346, 6018, 7535, 6092, 4924,
-4237, 1198, 1228, 1286, 619, 3219, 3498, 3436, 6704, 6679, 6946,
-4238, 812, 235, 174, 30, 7300, 6147, 1842, 7536, 3698, 3598,
-4239, 1195, 632, 613, 644, 6182, 4954, 7537, 7055, 5048, 4993,
-4240, 858, 345, 307, 35, 6575, 4104, 5519, 6179, 4002, 3914,
-4241, 1082, 496, 549, 651, 6338, 4725, 6336, 7538, 5020, 5019,
-4242, 1035, 1036, 1137, 487, 2514, 2861, 2860, 5505, 5506, 7299,
-4243, 383, 944, 1077, 368, 5701, 2669, 7191, 4149, 5745, 5743,
-4244, 613, 644, 1189, 1195, 4993, 6548, 6547, 7537, 7055, 3058,
-4245, 385, 343, 1012, 1011, 4357, 7540, 7539, 7541, 7102, 2439,
-4246, 553, 1136, 465, 464, 7386, 7542, 4685, 4686, 7543, 4398,
-4247, 1138, 1037, 1139, 466, 2864, 2866, 2868, 6413, 7236, 7544,
-4248, 583, 494, 649, 1089, 4800, 5014, 5025, 6217, 7229, 6136,
-4249, 490, 467, 1140, 1038, 4485, 7545, 6128, 7546, 7547, 2869,
-4250, 682, 1341, 659, 733, 6787, 6789, 5127, 5303, 7548, 5301,
-4251, 357, 883, 1039, 884, 6653, 2521, 7549, 6652, 2023, 2522,
-4252, 881, 319, 356, 1037, 5595, 4066, 7297, 2515, 7234, 7235,
-4253, 724, 701, 1308, 695, 5333, 6274, 5684, 5360, 5261, 5685,
-4254, 374, 802, 231, 957, 6645, 7336, 4128, 6646, 2283, 7241,
-4255, 345, 35, 858, 36, 4002, 6179, 6575, 4001, 1559, 7550,
-4256, 947, 791, 792, 227, 2252, 1784, 2253, 6100, 6101, 6790,
-4257, 496, 950, 479, 371, 6891, 7294, 4512, 4513, 6890, 4466,
-4258, 362, 1049, 1050, 894, 7551, 2556, 6692, 6690, 2552, 2554,
-4259, 342, 812, 175, 30, 6722, 1843, 6207, 3990, 7536, 3597,
-4260, 473, 1049, 1151, 1050, 6608, 2902, 7110, 7266, 2556, 2903,
-4261, 587, 609, 1184, 1269, 4918, 6661, 6089, 6036, 6885, 3381,
-4262, 1020, 347, 384, 1019, 6087, 4150, 5951, 2466, 7552, 5950,
-4263, 1210, 598, 1079, 1080, 6388, 6389, 3118, 3119, 6900, 2680,
-4264, 1216, 1093, 572, 1092, 3153, 7554, 7553, 3152, 2725, 7555,
-4265, 231, 800, 21, 337, 5871, 7204, 3691, 4078, 5966, 3979,
-4266, 270, 1061, 416, 269, 7133, 7116, 4245, 3805, 7556, 4244,
-4267, 385, 238, 1012, 343, 4152, 6226, 7539, 4357, 4110, 7540,
-4268, 990, 269, 415, 1061, 7239, 4242, 5517, 2600, 7556, 5518,
-4269, 535, 1157, 633, 632, 5655, 6799, 4955, 4953, 6183, 4957,
-4270, 560, 554, 472, 1149, 4706, 4689, 4704, 6042, 7557, 7433,
-4271, 415, 269, 416, 1061, 4242, 4244, 4246, 5518, 7556, 7116,
-4272, 1374, 222, 4, 816, 7558, 1459, 6602, 7559, 1856, 1855,
-4273, 762, 1291, 759, 718, 6445, 6444, 5413, 5404, 7560, 5393,
-4274, 925, 117, 288, 844, 2125, 7562, 7561, 2208, 1916, 7563,
-4275, 490, 1039, 1141, 1040, 7564, 2872, 6127, 7565, 2526, 2873,
-4276, 697, 1280, 653, 676, 6356, 6355, 5174, 5175, 6351, 5105,
-4277, 308, 1014, 456, 1015, 7566, 6116, 4367, 6558, 2451, 6117,
-4278, 999, 456, 1154, 426, 7193, 5790, 2914, 7290, 4714, 7169,
-4279, 858, 181, 859, 36, 1944, 1946, 1948, 7550, 7568, 7567,
-4280, 451, 1018, 1019, 310, 7569, 2463, 7265, 4350, 7256, 5641,
-4281, 572, 1215, 1216, 1092, 7570, 3154, 7553, 7555, 3149, 3152,
-4282, 1316, 686, 1283, 1259, 6344, 7571, 3114, 3537, 6289, 3534,
-4283, 47, 193, 870, 48, 7260, 1980, 6781, 1571, 6585, 6995,
-4284, 831, 62, 1377, 265, 7574, 7573, 7572, 7575, 3788, 6710,
-4285, 686, 664, 1316, 1283, 5150, 7576, 6344, 7571, 7577, 3114,
-4286, 1231, 487, 1136, 1137, 7579, 7578, 3078, 3226, 7299, 2862,
-4287, 825, 907, 252, 50, 2194, 6761, 6720, 7580, 7331, 3750,
-4288, 1284, 686, 1283, 664, 6570, 7571, 3525, 6571, 5150, 7577,
-4289, 1150, 1049, 472, 1048, 2900, 6609, 7581, 2899, 2553, 6675,
-4290, 892, 70, 215, 893, 7037, 7068, 2046, 2050, 7039, 2048,
-4291, 548, 1010, 1158, 1183, 5807, 2930, 6572, 6802, 3022, 3021,
-4292, 836, 919, 218, 73, 2174, 2111, 1897, 7197, 6028, 6097,
-4293, 1220, 1237, 1164, 641, 3255, 3254, 3167, 6369, 5571, 6261,
-4294, 1269, 1250, 679, 663, 3414, 6854, 6852, 6857, 6855, 5122,
-4295, 385, 1011, 1012, 1072, 7541, 2439, 7539, 7582, 2800, 2641,
-4296, 1008, 1172, 1167, 545, 2970, 2969, 2958, 7583, 6253, 6252,
-4297, 451, 1120, 384, 1019, 5942, 7584, 4353, 7265, 2810, 5950,
-4298, 1184, 609, 501, 500, 6661, 4917, 6660, 6843, 4887, 4526,
-4299, 587, 1269, 672, 663, 6036, 7585, 5093, 5170, 6857, 5171,
-4300, 546, 1070, 547, 1169, 6871, 5731, 4672, 6300, 2965, 6257,
-4301, 548, 1183, 1165, 1009, 6802, 3034, 6193, 5664, 3033, 2951,
-4302, 1012, 1072, 900, 238, 2641, 2640, 2446, 6226, 7586, 5568,
-4303, 1232, 1296, 559, 1201, 3488, 6867, 6006, 3235, 3464, 6021,
-4304, 1254, 620, 1188, 587, 6850, 7587, 3332, 6035, 4812, 6034,
-4305, 648, 1201, 1296, 1267, 6533, 3464, 7505, 6489, 3463, 3465,
-4306, 1318, 1338, 1294, 765, 1726, 3213, 3214, 7588, 7589, 6321,
-4307, 535, 432, 1064, 1063, 4632, 5839, 5653, 5910, 5911, 2613,
-4308, 385, 1072, 1012, 238, 7582, 2641, 7539, 4152, 7586, 6226,
-4309, 1023, 312, 868, 349, 5698, 7590, 2474, 5507, 4059, 5509,
-4310, 1158, 386, 387, 997, 7592, 4159, 7591, 2931, 7044, 7593,
-4311, 539, 636, 538, 1171, 4965, 4964, 4647, 7594, 6762, 6312,
-4312, 894, 71, 325, 893, 5676, 3950, 6851, 2053, 5675, 7595,
-4313, 495, 450, 385, 1158, 4510, 4462, 4511, 6573, 6574, 7596,
-4314, 749, 1251, 1297, 741, 7497, 3466, 7597, 5351, 7598, 6596,
-4315, 691, 689, 1253, 741, 5259, 7123, 7599, 5350, 5327, 7600,
-4316, 1012, 343, 238, 237, 7540, 4110, 6226, 6227, 3994, 3709,
-4317, 1068, 442, 441, 543, 7061, 4325, 6222, 6514, 4658, 4657,
-4318, 1123, 498, 1122, 455, 6403, 7601, 2820, 5748, 4517, 6662,
-4319, 386, 1072, 997, 1158, 7602, 2642, 7044, 7592, 2928, 2931,
-4320, 1176, 1080, 580, 598, 2999, 7604, 7603, 6899, 6900, 4862,
-4321, 1230, 1285, 647, 1261, 3434, 5538, 6560, 3350, 3435, 5540,
-4322, 1256, 1254, 688, 1289, 3447, 7375, 7605, 3449, 3451, 7377,
-4323, 335, 795, 479, 796, 6232, 6285, 4443, 7606, 1796, 7607,
-4324, 228, 949, 793, 476, 6894, 2258, 6409, 4426, 5769, 6387,
-4325, 1094, 493, 615, 1093, 7303, 4902, 5525, 2731, 7031, 7608,
-4326, 738, 767, 736, 1371, 5426, 5425, 5323, 6526, 6527, 6667,
-4327, 1092, 1091, 961, 376, 2722, 2718, 2720, 7609, 7610, 5602,
-4328, 679, 710, 1240, 1256, 5356, 6288, 7309, 6853, 7277, 3349,
-4329, 736, 759, 1360, 770, 5446, 5980, 5978, 5464, 5463, 6366,
-4330, 615, 1216, 1217, 1093, 7611, 3156, 5526, 7608, 3153, 3157,
-4331, 1269, 672, 679, 1256, 7585, 5252, 6852, 3444, 7612, 6853,
-4332, 963, 377, 340, 808, 7140, 4134, 7613, 2301, 6777, 6776,
-4333, 744, 772, 742, 1356, 5466, 5465, 5336, 7614, 6958, 6957,
-4334, 918, 273, 420, 274, 7339, 4256, 7056, 6670, 3817, 4257,
-4335, 562, 1087, 649, 1088, 6131, 7506, 5011, 6130, 2710, 6137,
-4336, 1052, 1115, 1153, 475, 2974, 2983, 2909, 5941, 7616, 7615,
-4337, 1365, 1359, 777, 768, 1657, 6493, 6491, 6265, 6263, 5492,
-4338, 473, 1151, 1152, 1050, 7110, 2907, 7219, 7266, 2903, 2905,
-4339, 1242, 590, 694, 625, 7481, 5168, 6104, 7523, 4933, 5169,
-4340, 894, 893, 325, 1049, 2053, 7595, 6851, 2552, 2551, 6610,
-4341, 419, 525, 418, 992, 4602, 4601, 4255, 7617, 7359, 5920,
-4342, 417, 523, 416, 1103, 4596, 4595, 4249, 6600, 6601, 7115,
-4343, 1376, 216, 893, 71, 7070, 2049, 7076, 7025, 5674, 5675,
-4344, 625, 1223, 1241, 1174, 7619, 3280, 7618, 7524, 3191, 3281,
-4345, 396, 979, 507, 506, 6543, 7620, 4543, 4541, 6919, 4545,
-4346, 417, 416, 991, 1103, 4249, 7114, 7621, 6600, 7115, 2755,
-4347, 515, 1245, 1105, 516, 7489, 3296, 7488, 4574, 7507, 6817,
-4348, 507, 396, 397, 979, 4543, 4189, 4544, 7620, 6543, 6544,
-4349, 492, 1228, 606, 488, 6677, 6678, 4874, 4505, 6693, 4873,
-4350, 991, 271, 834, 916, 7217, 6210, 2380, 2381, 7218, 2203,
-4351, 207, 831, 208, 62, 1888, 1887, 1444, 7622, 7574, 7623,
-4352, 1354, 756, 1343, 1357, 6282, 6970, 1673, 1654, 6283, 1672,
-4353, 887, 1043, 359, 888, 2533, 7624, 7448, 2035, 2534, 5820,
-4354, 407, 1105, 516, 515, 7423, 6817, 4572, 4570, 7488, 4574,
-4355, 186, 41, 187, 864, 5751, 7625, 1423, 1961, 7130, 1962,
-4356, 1362, 764, 733, 1349, 6108, 5412, 6106, 1624, 6447, 7469,
-4357, 1187, 1105, 1057, 515, 3032, 2761, 3030, 7490, 7488, 7414,
-4358, 1057, 1105, 407, 515, 2761, 7423, 7413, 7414, 7488, 4570,
-4359, 1104, 984, 403, 513, 2757, 6476, 6477, 5544, 7475, 4562,
-4360, 401, 400, 254, 982, 4201, 4197, 4199, 5992, 5738, 6879,
-4361, 503, 391, 1056, 1114, 4530, 7383, 7382, 5861, 5862, 2791,
-4362, 1308, 1322, 724, 1311, 3227, 7626, 5684, 3524, 3209, 5686,
-4363, 502, 1114, 501, 390, 5860, 7627, 4529, 4527, 7628, 4525,
-4364, 385, 238, 239, 1072, 4152, 3712, 4153, 7582, 7586, 7405,
-4365, 501, 1114, 1163, 390, 7627, 2946, 6032, 4525, 7628, 6033,
-4366, 749, 1300, 1297, 1251, 7629, 3427, 7597, 7497, 3479, 3466,
-4367, 742, 1356, 1364, 1358, 6957, 1634, 6484, 6467, 1671, 1655,
-4368, 459, 381, 350, 1026, 4381, 4142, 4378, 7532, 7200, 7202,
-4369, 1226, 1225, 617, 1257, 3256, 6628, 6808, 2986, 3355, 6629,
-4370, 567, 1127, 1227, 566, 7321, 3212, 5608, 4733, 7630, 6708,
-4371, 567, 566, 459, 1127, 4733, 4729, 4731, 7321, 7630, 7320,
-4372, 502, 1114, 1188, 501, 5860, 3035, 6074, 4529, 7627, 7631,
-4373, 261, 986, 407, 260, 6949, 6947, 4218, 3778, 6807, 4217,
-4374, 351, 49, 871, 194, 4015, 6622, 6589, 7632, 7325, 1983,
-4375, 557, 556, 1142, 468, 4789, 7494, 6883, 4695, 4692, 6880,
-4376, 1139, 466, 550, 1138, 7544, 4680, 7421, 2868, 6413, 6411,
-4377, 1138, 487, 550, 1137, 6412, 4783, 6411, 2865, 7299, 7135,
-4378, 1353, 721, 738, 725, 6553, 5321, 6615, 7633, 5283, 5322,
-4379, 869, 1025, 1024, 313, 2479, 2481, 2477, 7634, 7636, 7635,
-4380, 1232, 1140, 559, 1139, 3082, 6007, 6006, 3081, 2871, 6929,
-4381, 1134, 564, 489, 552, 7637, 4717, 5958, 6536, 4720, 4684,
-4382, 1188, 1114, 1163, 501, 3035, 2946, 3036, 7631, 7627, 6032,
-4383, 1128, 1127, 381, 566, 2835, 7264, 7263, 7638, 7630, 4728,
-4384, 661, 600, 645, 1261, 5067, 4995, 5068, 6725, 7639, 5541,
-4385, 890, 323, 1045, 889, 7244, 6177, 2540, 2041, 6181, 2539,
-4386, 353, 1031, 463, 1032, 5500, 5796, 4392, 7214, 2502, 5946,
-4387, 381, 1127, 459, 566, 7264, 7320, 4381, 4728, 7630, 4729,
-4388, 1334, 1319, 702, 760, 1712, 6005, 6003, 6973, 6464, 5395,
-4389, 1364, 1358, 775, 742, 1655, 6268, 6266, 6484, 6467, 5458,
-4390, 745, 765, 734, 1294, 5415, 5414, 5390, 7640, 6321, 6320,
-4391, 392, 904, 821, 246, 7642, 2159, 7641, 4173, 7460, 7643,
-4392, 478, 497, 1073, 367, 4780, 7645, 7644, 4437, 4726, 7646,
-4393, 538, 436, 1054, 435, 4642, 7347, 6311, 4641, 4307, 7175,
-4394, 714, 665, 1271, 652, 5224, 6697, 7240, 5223, 5077, 6698,
-4395, 731, 1337, 1304, 711, 7466, 2982, 6924, 5293, 7647, 6925,
-4396, 567, 1126, 370, 1125, 7318, 7648, 4732, 7649, 2829, 6738,
-4397, 1200, 1139, 550, 1138, 3080, 7421, 7136, 3079, 2868, 6411,
-4398, 1035, 355, 880, 1036, 5503, 6325, 2510, 2514, 5504, 2512,
-4399, 942, 786, 787, 225, 2237, 1769, 2238, 7113, 7090, 7081,
-4400, 1277, 740, 671, 674, 7408, 5221, 5560, 5561, 5220, 5147,
-4401, 880, 318, 1035, 879, 7650, 7451, 2510, 2011, 7651, 2509,
-4402, 894, 1049, 325, 362, 2552, 6610, 6851, 6690, 7551, 4072,
-4403, 1360, 1371, 767, 1369, 1645, 6527, 6367, 1646, 1631, 7652,
-4404, 1024, 1125, 370, 1126, 2825, 6738, 6739, 2827, 2829, 7648,
-4405, 1323, 1309, 723, 1316, 3412, 6391, 5673, 3476, 3477, 5671,
-4406, 1090, 494, 375, 571, 5530, 4743, 5529, 7313, 4795, 4748,
-4407, 77, 222, 1374, 816, 6162, 7558, 7653, 6120, 1856, 7559,
-4408, 1244, 592, 629, 1185, 7655, 4942, 7654, 3291, 7657, 7656,
-4409, 246, 904, 188, 189, 7460, 2081, 7658, 7659, 2080, 1425,
-4410, 658, 618, 576, 1234, 5061, 4913, 5059, 6674, 7660, 5600,
-4411, 593, 1260, 671, 629, 7522, 5562, 5092, 5030, 5590, 5091,
-4412, 1310, 1342, 1299, 699, 3151, 3142, 3155, 6540, 6541, 7661,
-4413, 361, 893, 892, 1048, 7038, 2050, 7011, 6868, 2549, 2548,
-4414, 1151, 1203, 1150, 554, 3092, 3091, 2904, 7429, 7662, 7430,
-4415, 404, 258, 985, 910, 4209, 7445, 5497, 5498, 6373, 2363,
-4416, 1351, 1338, 1318, 776, 1668, 1726, 1727, 7312, 7095, 7663,
-4417, 1365, 768, 777, 776, 6265, 5492, 6491, 7094, 5462, 5482,
-4418, 561, 1235, 560, 1148, 6826, 6044, 4710, 6727, 3243, 6043,
-4419, 978, 394, 1156, 1058, 7664, 6174, 2921, 2587, 7665, 3010,
-4420, 325, 893, 71, 70, 7595, 5675, 3950, 3951, 7039, 1594,
-4421, 625, 513, 626, 1223, 4932, 4823, 5042, 7619, 5543, 7666,
-4422, 472, 1149, 1148, 560, 7433, 2898, 7431, 4704, 6042, 6043,
-4423, 1150, 1203, 1149, 554, 3091, 3246, 2901, 7430, 7662, 7557,
-4424, 592, 1185, 628, 519, 7657, 6142, 5043, 4827, 7427, 4940,
-4425, 1243, 1182, 1260, 629, 3359, 3365, 3364, 6639, 7149, 5590,
-4426, 1287, 1271, 714, 665, 3438, 7240, 7667, 6931, 6697, 5224,
-4427, 11, 788, 151, 150, 7668, 1771, 3554, 3555, 1770, 1386,
-4428, 210, 887, 209, 64, 2031, 2030, 1446, 7669, 6192, 7670,
-4429, 367, 475, 1115, 454, 4518, 7616, 6753, 4364, 4463, 6756,
-4430, 487, 1231, 1136, 553, 7579, 3078, 7578, 4687, 7385, 7386,
-4431, 383, 226, 944, 368, 4146, 6221, 5701, 4149, 4116, 5745,
-4432, 230, 337, 20, 799, 4050, 3980, 3688, 6996, 5967, 6779,
-4433, 373, 799, 955, 337, 7671, 2276, 5914, 4125, 5967, 5965,
-4434, 771, 1348, 769, 1370, 7673, 7672, 5436, 7674, 1641, 6992,
-4435, 1019, 310, 1018, 863, 5641, 7256, 2463, 2461, 5643, 2459,
-4436, 451, 346, 1018, 310, 4351, 7254, 7569, 4350, 4105, 7256,
-4437, 1118, 1196, 574, 599, 3061, 7392, 7393, 7675, 7676, 4882,
-4438, 384, 310, 1019, 347, 4151, 5641, 5950, 4150, 4057, 7552,
-4439, 230, 799, 373, 337, 6996, 7671, 4126, 4050, 5967, 4125,
-4440, 987, 517, 518, 410, 5592, 4581, 5827, 5921, 4578, 4579,
-4441, 963, 808, 340, 807, 2301, 6776, 7613, 2300, 1832, 7677,
-4442, 29, 810, 341, 235, 7053, 7122, 3987, 3699, 7054, 4082,
-4443, 831, 207, 1377, 62, 1888, 7678, 7572, 7574, 7622, 7573,
-4444, 831, 913, 1377, 207, 2200, 6711, 7572, 1888, 2098, 7678,
-4445, 629, 1185, 520, 1182, 7656, 6361, 4943, 7149, 3172, 6363,
-4446, 1299, 674, 1244, 690, 7410, 7679, 3474, 7680, 5160, 7681,
-4447, 391, 1114, 502, 390, 5862, 5860, 4528, 4171, 7628, 4527,
-4448, 803, 802, 165, 338, 1817, 1813, 1815, 6280, 7105, 6279,
-4449, 487, 1136, 465, 553, 7578, 7542, 4472, 4687, 7386, 4685,
-4450, 815, 425, 814, 329, 6978, 5612, 1853, 6122, 4273, 5611,
-4451, 1021, 311, 866, 348, 7093, 7682, 2468, 7092, 4058, 5589,
-4452, 1306, 1293, 650, 1290, 3041, 6308, 7683, 3040, 3039, 7684,
-4453, 1376, 71, 893, 70, 7025, 5675, 7076, 7026, 1594, 7039,
-4454, 1255, 1192, 748, 1246, 3335, 6096, 7378, 3334, 3307, 7685,
-4455, 790, 13, 791, 333, 5693, 5692, 1781, 7686, 3971, 7687,
-4456, 1055, 414, 990, 832, 5857, 6019, 2575, 2573, 5859, 2378,
-4457, 1295, 1323, 735, 697, 1698, 5927, 7454, 7456, 5672, 5398,
-4458, 1100, 388, 976, 387, 7516, 7519, 2749, 7688, 4162, 6079,
-4459, 901, 976, 241, 240, 2338, 6077, 6148, 6834, 6078, 3718,
-4460, 656, 1247, 681, 720, 5786, 6241, 5125, 5245, 6234, 5246,
-4461, 502, 501, 1188, 587, 4529, 7631, 6074, 4809, 4808, 6034,
-4462, 1254, 620, 672, 688, 6850, 5094, 6849, 7375, 5152, 5151,
-4463, 243, 820, 902, 40, 6154, 2156, 7689, 3722, 5902, 7035,
-4464, 638, 1246, 639, 708, 5864, 6040, 4975, 5208, 6072, 5210,
-4465, 1253, 588, 1254, 688, 7125, 7690, 3333, 7376, 5178, 7375,
-4466, 1033, 1135, 1134, 464, 2854, 2856, 2852, 7691, 7692, 6535,
-4467, 843, 115, 85, 116, 1914, 3623, 7693, 1913, 1469, 3624,
-4468, 138, 102, 304, 103, 3663, 3905, 7694, 3664, 1552, 3906,
-4469, 353, 876, 1032, 877, 5502, 2500, 7214, 7492, 2002, 2501,
-4470, 1351, 739, 1327, 1344, 6441, 6442, 1729, 1703, 6845, 1728,
-4471, 303, 136, 137, 935, 7696, 1490, 7695, 7697, 2147, 2146,
-4472, 714, 731, 1287, 665, 5291, 6930, 7667, 5224, 5292, 6931,
-4473, 869, 349, 1024, 868, 7698, 5508, 2477, 1978, 5509, 2476,
-4474, 1175, 1205, 558, 1204, 3189, 7443, 7442, 3308, 3099, 7699,
-4475, 1346, 730, 703, 1335, 7701, 5391, 7700, 1715, 6563, 6664,
-4476, 1219, 523, 594, 630, 7702, 4832, 6347, 6402, 4945, 4947,
-4477, 1111, 521, 1243, 522, 6822, 6638, 3290, 6156, 4594, 6155,
-4478, 781, 223, 1013, 328, 6046, 5850, 2443, 6047, 4042, 5849,
-4479, 286, 843, 924, 115, 5882, 2207, 5883, 7703, 1914, 2123,
-4480, 781, 5, 1374, 143, 5603, 7515, 7704, 1750, 3542, 6603,
-4481, 286, 85, 287, 843, 3852, 3854, 3856, 5882, 7693, 6960,
-4482, 415, 414, 1111, 521, 4243, 6020, 5516, 4590, 4589, 6822,
-4483, 936, 854, 449, 304, 2189, 6618, 6617, 7705, 6126, 4344,
-4484, 936, 304, 449, 305, 7705, 4344, 6617, 7189, 3910, 4345,
-4485, 781, 77, 1374, 5, 6045, 7653, 7704, 5603, 3673, 7515,
-4486, 64, 266, 914, 267, 3792, 5582, 5581, 3794, 3796, 5548,
-4487, 503, 502, 1222, 620, 4532, 6073, 6169, 4811, 4810, 7706,
-4488, 1034, 1135, 1033, 464, 2855, 2854, 2508, 7707, 7692, 7691,
-4489, 1218, 1159, 528, 1095, 3185, 5708, 6922, 3161, 3163, 7085,
-4490, 465, 1136, 1034, 464, 7542, 2857, 7708, 4398, 7543, 7707,
-4491, 1339, 751, 1342, 699, 6913, 7302, 1665, 6542, 5358, 6541,
-4492, 505, 1239, 1156, 1180, 6313, 3302, 6172, 6093, 3276, 3016,
-4493, 847, 292, 123, 928, 7710, 7709, 1922, 2224, 7711, 2132,
-4494, 1120, 1018, 451, 1119, 2809, 7569, 5942, 2811, 2807, 5952,
-4495, 353, 877, 54, 876, 7492, 7712, 4018, 5502, 2002, 7713,
-4496, 54, 877, 199, 876, 7712, 2000, 6768, 7713, 2002, 1998,
-4497, 198, 876, 54, 199, 1997, 7713, 7714, 1435, 1998, 6768,
-4498, 270, 916, 991, 1061, 6196, 2381, 7132, 7133, 2601, 2648,
-4499, 353, 876, 54, 53, 5502, 7713, 4018, 4019, 7715, 1577,
-4500, 269, 1061, 833, 916, 7556, 2599, 6805, 6804, 2601, 2171,
-4501, 198, 199, 54, 256, 1435, 6768, 7714, 7716, 6407, 3762,
-4502, 472, 560, 1148, 491, 4704, 6043, 7431, 4492, 4705, 6728,
-4503, 210, 887, 65, 888, 2031, 7449, 6795, 2033, 2035, 7450,
-4504, 65, 887, 210, 64, 7449, 2031, 6795, 1588, 6192, 7669,
-4505, 622, 1193, 691, 621, 7346, 7717, 5161, 4924, 6092, 5158,
-4506, 1251, 1193, 691, 622, 3320, 7717, 7418, 7420, 7346, 5161,
-4507, 1102, 1179, 510, 509, 3007, 5658, 5659, 6989, 7534, 4554,
-4508, 1156, 394, 978, 393, 6174, 7664, 2921, 7718, 4180, 7719,
-4509, 1056, 504, 1156, 393, 6588, 6173, 2922, 7720, 4534, 7718,
-4510, 539, 1170, 637, 636, 7131, 5880, 4967, 4965, 6303, 4969,
-4511, 63, 886, 209, 208, 6185, 2028, 7721, 7722, 2027, 1445,
-4512, 1199, 1286, 660, 1285, 3483, 6068, 6865, 3468, 3484, 7723,
-4513, 846, 292, 436, 928, 7168, 4306, 7167, 2181, 7711, 7179,
-4514, 326, 1050, 474, 1051, 6691, 6598, 4423, 7262, 2559, 6418,
-4515, 327, 1052, 1053, 897, 5940, 2566, 5635, 7306, 2561, 2563,
-4516, 1055, 413, 1109, 520, 5858, 7724, 2772, 7725, 4586, 6362,
-4517, 155, 156, 793, 15, 1391, 1786, 1785, 3564, 3563, 6410,
-4518, 496, 1082, 951, 950, 6338, 2687, 7296, 6891, 2685, 2266,
-4519, 1291, 662, 1328, 1278, 7727, 7726, 2736, 3260, 7728, 3259,
-4520, 221, 898, 76, 899, 2064, 5846, 6859, 2066, 2068, 5847,
-4521, 220, 75, 221, 898, 7120, 7729, 1457, 2063, 5844, 2064,
-4522, 221, 75, 76, 898, 7729, 1599, 6859, 2064, 5844, 5846,
-4523, 1029, 488, 1130, 1028, 5997, 6695, 2840, 2493, 5999, 2839,
-4524, 908, 197, 255, 826, 2088, 6450, 7730, 2195, 1878, 6982,
-4525, 76, 75, 364, 898, 1599, 4041, 4040, 5846, 5844, 5842,
-4526, 1376, 70, 893, 215, 7026, 7039, 7076, 6963, 7068, 2048,
-4527, 691, 1193, 1253, 589, 7717, 3327, 7599, 5157, 7208, 7124,
-4528, 826, 401, 402, 255, 5991, 4204, 7248, 6982, 4200, 4202,
-4529, 682, 1341, 1332, 1298, 6787, 1732, 5869, 6786, 3090, 3159,
-4530, 909, 255, 826, 402, 6983, 6982, 2164, 7230, 4202, 7248,
-4531, 1253, 1193, 691, 1251, 3327, 7717, 7599, 3329, 3320, 7418,
-4532, 1307, 684, 1313, 1267, 7732, 7731, 1734, 1735, 7733, 1733,
-4533, 1149, 1203, 560, 554, 3246, 6803, 6042, 7557, 7662, 4706,
-4534, 1204, 1203, 1151, 554, 3095, 3092, 3093, 7734, 7662, 7429,
-4535, 628, 592, 1244, 1185, 5043, 7655, 6141, 6142, 7657, 3291,
-4536, 1092, 961, 483, 376, 2720, 7396, 7397, 7609, 5602, 4498,
-4537, 1147, 1146, 551, 1202, 2892, 7735, 6115, 3088, 3087, 7736,
-4538, 1320, 1275, 1276, 717, 3536, 3520, 3265, 6906, 5964, 5962,
-4539, 1361, 753, 1342, 1366, 7737, 6828, 1661, 1620, 6415, 1662,
-4540, 723, 664, 669, 1316, 5258, 5172, 5270, 5671, 7576, 7738,
-4541, 1109, 411, 1160, 519, 6523, 7739, 2936, 6524, 4582, 6134,
-4542, 605, 1267, 648, 684, 7091, 6489, 5009, 5131, 7733, 5132,
-4543, 472, 554, 1150, 1149, 4689, 7430, 7581, 7433, 7557, 2901,
-4544, 703, 1335, 1331, 1346, 6664, 1716, 6942, 7700, 1715, 1602,
-4545, 1211, 662, 651, 1278, 6200, 5070, 6199, 3409, 7728, 7740,
-4546, 685, 1290, 1272, 1306, 7741, 3452, 7249, 6204, 3040, 3506,
-4547, 1155, 1191, 633, 1157, 3045, 6798, 7742, 2996, 3046, 6799,
-4548, 1325, 718, 759, 1291, 6735, 5393, 7142, 3495, 7560, 6444,
-4549, 1363, 744, 778, 751, 7743, 5469, 7426, 7744, 5399, 5470,
-4550, 1043, 322, 470, 486, 7745, 4412, 6715, 6716, 4468, 4470,
-4551, 1281, 1214, 669, 653, 3423, 6050, 6049, 5829, 5830, 5086,
-4552, 650, 667, 1306, 685, 5082, 6392, 7683, 5135, 5137, 6204,
-4553, 929, 1003, 439, 1004, 2415, 6941, 7367, 2417, 2420, 6952,
-4554, 9, 8, 331, 148, 1501, 3967, 3966, 3551, 3549, 7394,
-4555, 1045, 1146, 1044, 471, 2888, 2887, 2541, 5629, 5630, 6176,
-4556, 441, 542, 440, 1006, 4655, 4654, 4322, 6224, 6225, 7491,
-4557, 550, 559, 1200, 614, 4702, 6866, 7136, 4900, 4899, 6469,
-4558, 1341, 1349, 1362, 733, 1692, 1624, 1691, 7548, 7469, 6106,
-4559, 426, 282, 427, 972, 4276, 4278, 4280, 7170, 7746, 6579,
-4560, 295, 94, 296, 930, 3879, 3881, 3883, 7462, 6961, 7747,
-4561, 385, 1072, 386, 1158, 7582, 7602, 4156, 7596, 2928, 7592,
-4562, 1006, 1003, 1099, 541, 2579, 2747, 2746, 7748, 5707, 6665,
-4563, 108, 921, 109, 79, 2115, 2117, 1462, 3610, 7749, 3611,
-4564, 649, 653, 583, 1213, 5035, 5037, 5025, 6138, 5831, 7750,
-4565, 914, 64, 209, 63, 5581, 7670, 2100, 5583, 1587, 7721,
-4566, 491, 1147, 561, 1148, 7751, 6114, 4707, 6728, 2895, 6727,
-4567, 657, 675, 614, 1302, 5103, 5102, 5057, 7752, 5988, 6774,
-4568, 543, 640, 542, 1168, 4977, 4976, 4659, 6515, 6520, 6516,
-4569, 297, 442, 931, 850, 4323, 7203, 5565, 5834, 6940, 2212,
-4570, 683, 1312, 702, 743, 7753, 6004, 5189, 5331, 7509, 5364,
-4571, 951, 795, 479, 950, 2264, 6285, 7295, 2266, 2262, 7294,
-4572, 653, 1214, 583, 1213, 5830, 6218, 5037, 5831, 3145, 7750,
-4573, 930, 296, 440, 849, 7747, 4318, 7754, 2211, 6909, 6907,
-4574, 846, 927, 1054, 435, 2131, 2569, 2568, 7348, 6456, 7175,
-4575, 97, 299, 298, 932, 3890, 3892, 3888, 7755, 5742, 5740,
-4576, 1281, 653, 1178, 1213, 5829, 6360, 3419, 3420, 5831, 3139,
-4577, 1021, 1122, 458, 455, 2816, 6301, 6302, 6663, 6662, 4377,
-4578, 902, 820, 243, 977, 2156, 6154, 7689, 2342, 2341, 6861,
-4579, 452, 1117, 569, 574, 5532, 6236, 4740, 4758, 6237, 4772,
-4580, 1243, 1260, 593, 629, 3364, 7522, 6637, 6639, 5590, 5030,
-4581, 1046, 1147, 491, 1148, 2891, 7751, 7756, 2893, 2895, 6728,
-4582, 495, 601, 548, 1183, 4856, 4858, 4746, 7520, 5681, 6802,
-4583, 1056, 1114, 1222, 503, 2791, 3184, 3183, 7382, 5861, 6169,
-4584, 109, 79, 281, 80, 3611, 3836, 7389, 3612, 1529, 3837,
-4585, 450, 1010, 1011, 1158, 6433, 2638, 7101, 6574, 2930, 2929,
-4586, 1227, 1126, 567, 1125, 3068, 7318, 5608, 3067, 2829, 7649,
-4587, 726, 763, 1340, 754, 5406, 5969, 5968, 5370, 5407, 7757,
-4588, 1046, 1147, 471, 491, 2891, 5631, 7758, 7756, 7751, 4490,
-4589, 340, 962, 483, 963, 7759, 7398, 4451, 7613, 2302, 7139,
-4590, 1045, 471, 1046, 1147, 5629, 7758, 2544, 2890, 5631, 2891,
-4591, 1243, 521, 1182, 629, 6638, 7148, 3359, 6639, 4944, 7149,
-4592, 1244, 690, 628, 1248, 7681, 5159, 6141, 3312, 7761, 7760,
-4593, 591, 1194, 628, 1248, 6607, 6143, 4941, 6975, 3310, 7760,
-4594, 195, 907, 825, 50, 2086, 2194, 1876, 6626, 7331, 7580,
-4595, 40, 310, 41, 863, 3921, 3920, 1564, 7268, 5643, 7238,
-4596, 628, 690, 591, 1248, 5159, 5156, 4941, 7760, 7761, 6975,
-4597, 835, 273, 419, 420, 7340, 4254, 7762, 7057, 4256, 4258,
-4598, 1153, 1205, 474, 497, 3097, 7764, 7763, 7765, 7766, 4515,
-4599, 603, 497, 558, 1205, 4863, 4699, 4864, 7441, 7766, 7443,
-4600, 1034, 354, 1033, 878, 7528, 7525, 2508, 2506, 7527, 2504,
-4601, 1035, 318, 1034, 879, 7451, 7767, 2511, 2509, 7651, 2507,
-4602, 202, 57, 58, 880, 6242, 1581, 6170, 2009, 6326, 5596,
-4603, 903, 973, 821, 245, 2331, 2330, 2155, 7768, 7770, 7769,
-4604, 688, 588, 1254, 620, 5178, 7690, 7375, 5152, 4920, 6850,
-4605, 986, 829, 262, 912, 2366, 7772, 7771, 2368, 2167, 7425,
-4606, 986, 408, 262, 261, 6948, 4221, 7771, 6949, 4220, 3781,
-4607, 462, 1132, 463, 1030, 7496, 5795, 4478, 5783, 2845, 5797,
-4608, 645, 552, 647, 1261, 4996, 5002, 5001, 5541, 7773, 5540,
-4609, 4, 1374, 143, 222, 6602, 6603, 1378, 1459, 7558, 1749,
-4610, 517, 516, 408, 1105, 4577, 4573, 4575, 6707, 6817, 6706,
-4611, 408, 516, 407, 1105, 4573, 4572, 4222, 6706, 6817, 7423,
-4612, 292, 90, 122, 291, 3869, 3635, 7355, 3871, 3867, 7356,
-4613, 122, 90, 121, 291, 3635, 3634, 1475, 7356, 3867, 7027,
-4614, 241, 387, 976, 388, 4158, 6079, 6077, 4160, 4162, 7519,
-4615, 239, 238, 900, 1072, 3712, 5568, 5567, 7405, 7586, 2640,
-4616, 386, 1072, 385, 239, 7602, 7582, 4156, 4154, 7405, 4153,
-4617, 626, 1223, 627, 680, 7666, 6244, 4937, 5120, 6255, 5164,
-4618, 83, 842, 284, 113, 7158, 6955, 3846, 3619, 1912, 7774,
-4619, 284, 842, 923, 113, 6955, 2222, 5765, 7774, 1912, 2121,
-4620, 900, 36, 818, 181, 5569, 7363, 2219, 2072, 7568, 1862,
-4621, 1217, 664, 1284, 1283, 6750, 6571, 3440, 3432, 7577, 3525,
-4622, 420, 993, 992, 835, 6916, 2598, 6914, 7057, 2386, 2384,
-4623, 1186, 1270, 1240, 709, 3382, 3384, 3278, 6151, 6249, 6153,
-4624, 1252, 1270, 1186, 709, 3383, 3382, 3325, 6248, 6249, 6151,
-4625, 219, 919, 837, 74, 2110, 2206, 1900, 7307, 6027, 7775,
-4626, 545, 444, 1067, 544, 4664, 7777, 7776, 4666, 4662, 7778,
-4627, 446, 301, 934, 852, 4335, 7215, 7226, 7779, 7223, 2187,
-4628, 1240, 1270, 710, 709, 3384, 6812, 6288, 6153, 6249, 5297,
-4629, 710, 1270, 734, 709, 6812, 6247, 5307, 5297, 6249, 5306,
-4630, 1021, 455, 458, 311, 6663, 4377, 6302, 7093, 4366, 4374,
-4631, 703, 1331, 1355, 1346, 6942, 1603, 7780, 7700, 1602, 1604,
-4632, 296, 95, 297, 128, 3882, 3884, 3886, 5574, 3646, 5573,
-4633, 583, 1214, 612, 1215, 6218, 7019, 5003, 6561, 3148, 6842,
-4634, 284, 82, 83, 113, 3845, 1532, 3846, 7774, 3618, 3619,
-4635, 901, 976, 240, 997, 2338, 6078, 6834, 2396, 2398, 6836,
-4636, 558, 497, 474, 1205, 4699, 4515, 4697, 7443, 7766, 7764,
-4637, 315, 50, 351, 873, 3931, 4014, 4085, 7781, 6625, 6623,
-4638, 392, 246, 821, 245, 4173, 7643, 7641, 4172, 3733, 7769,
-4639, 1196, 599, 578, 644, 7676, 4876, 6080, 6082, 4991, 4994,
-4640, 507, 1180, 506, 979, 7782, 6767, 4545, 7620, 3009, 6919,
-4641, 427, 841, 922, 283, 7783, 2223, 6578, 4279, 5713, 7784,
-4642, 540, 1004, 439, 1003, 6951, 6952, 4649, 5706, 2420, 6941,
-4643, 1293, 1203, 1263, 597, 3458, 3360, 3459, 6310, 7786, 7785,
-4644, 1274, 585, 616, 666, 5905, 5032, 5555, 5762, 5099, 5080,
-4645, 553, 1135, 464, 552, 7387, 7692, 4686, 4788, 7787, 4683,
-4646, 847, 123, 293, 124, 1922, 7788, 7381, 1921, 1477, 7789,
-4647, 27, 808, 171, 170, 6323, 1831, 3590, 3591, 1830, 1406,
-4648, 1244, 674, 1277, 1260, 7679, 5561, 3406, 3347, 5563, 3405,
-4649, 1304, 1292, 1271, 665, 3491, 3482, 3492, 6926, 7790, 6697,
-4650, 1053, 454, 1013, 938, 6061, 5851, 2565, 2655, 6757, 2572,
-4651, 1276, 662, 1211, 1278, 7791, 6200, 3403, 3408, 7728, 3409,
-4652, 64, 63, 886, 209, 1587, 6185, 6186, 7670, 7721, 2028,
-4653, 473, 326, 362, 1050, 4421, 4096, 4419, 7266, 6691, 6692,
-4654, 549, 577, 480, 1084, 4774, 4773, 4677, 7437, 7793, 7792,
-4655, 498, 530, 1197, 608, 4776, 5656, 6009, 4884, 4883, 6012,
-4656, 778, 1366, 771, 1370, 7794, 6414, 5475, 6993, 1607, 7674,
-4657, 790, 789, 12, 333, 1778, 7796, 7795, 7686, 7797, 3972,
-4658, 562, 1088, 374, 957, 6130, 7267, 4711, 6129, 2708, 6646,
-4659, 326, 1051, 363, 895, 7262, 6419, 4073, 6683, 2557, 7798,
-4660, 325, 893, 361, 1048, 7595, 7038, 4095, 6676, 2549, 6868,
-4661, 897, 75, 364, 327, 5843, 4041, 5841, 7306, 3954, 4074,
-4662, 326, 894, 1050, 895, 6681, 2554, 6691, 6683, 2056, 2555,
-4663, 1153, 475, 1115, 497, 7615, 7616, 2983, 7765, 4514, 7799,
-4664, 175, 31, 342, 30, 3600, 3989, 6207, 3597, 1523, 3990,
-4665, 1064, 535, 536, 432, 5653, 4636, 5840, 5839, 4632, 4634,
-4666, 1153, 1115, 1073, 497, 2983, 2795, 3044, 7765, 7799, 7645,
-4667, 230, 336, 480, 953, 4077, 4445, 4444, 5606, 6998, 5607,
-4668, 1321, 715, 1332, 1303, 7257, 5868, 1724, 1736, 5867, 1737,
-4669, 452, 453, 1117, 574, 4360, 7800, 5532, 4758, 4757, 6237,
-4670, 1303, 715, 682, 661, 5867, 5285, 5866, 7045, 5227, 5128,
-4671, 661, 1298, 682, 1303, 6723, 6786, 5128, 7045, 3407, 5866,
-4672, 331, 225, 9, 786, 3991, 3679, 3966, 7089, 7090, 7100,
-4673, 38, 344, 309, 861, 3998, 4003, 3919, 6146, 6531, 6145,
-4674, 224, 939, 478, 784, 6987, 7801, 4436, 5700, 2229, 5699,
-4675, 682, 1298, 1332, 1303, 6786, 3159, 5869, 5866, 3407, 1737,
-4676, 195, 196, 51, 825, 1432, 7803, 7802, 1876, 1875, 7804,
-4677, 839, 179, 34, 1375, 2071, 5903, 6427, 6425, 6426, 6506,
-4678, 563, 1074, 1205, 603, 5646, 3188, 7805, 4865, 5930, 7441,
-4679, 727, 720, 1265, 1314, 5276, 6233, 6393, 7806, 6235, 3462,
-4680, 654, 1314, 1266, 720, 7807, 3268, 6251, 5247, 6235, 7362,
-4681, 550, 1200, 1231, 604, 7136, 3229, 7134, 4869, 7252, 7808,
-4682, 1377, 913, 264, 207, 6711, 6712, 6709, 7678, 2098, 7809,
-4683, 1331, 1313, 721, 1324, 3202, 6552, 6554, 1719, 3201, 6549,
-4684, 988, 1109, 989, 412, 2771, 2770, 2375, 6893, 6522, 5580,
-4685, 480, 577, 1085, 1084, 4773, 7810, 5622, 7792, 7793, 2701,
-4686, 594, 522, 1243, 593, 4831, 6155, 6345, 4833, 4830, 6637,
-4687, 1315, 1314, 1266, 654, 1741, 3268, 3269, 7233, 7807, 6251,
-4688, 727, 1314, 654, 720, 7806, 7807, 5275, 5276, 6235, 5247,
-4689, 1244, 1185, 629, 1260, 3291, 7656, 7654, 3347, 3346, 5590,
-4690, 990, 268, 267, 414, 6831, 3799, 7333, 6019, 4239, 4238,
-4691, 992, 420, 525, 1108, 6914, 4604, 7359, 2769, 6915, 7358,
-4692, 961, 806, 962, 233, 2295, 2297, 2299, 7811, 7813, 7812,
-4693, 770, 1336, 759, 1360, 7814, 7143, 5463, 6366, 1705, 5980,
-4694, 33, 32, 815, 177, 1525, 6605, 5749, 3604, 3601, 1851,
-4695, 969, 379, 968, 813, 7344, 5812, 2320, 2318, 5917, 2316,
-4696, 781, 143, 1374, 222, 1750, 6603, 7704, 2070, 1749, 7558,
-4697, 506, 1058, 1156, 395, 6766, 3010, 6765, 4540, 7013, 7815,
-4698, 782, 781, 144, 223, 1754, 1751, 1752, 5855, 6046, 6794,
-4699, 507, 1180, 1107, 621, 7782, 3008, 6016, 4922, 6094, 7535,
-4700, 924, 998, 285, 842, 2402, 7816, 6771, 2177, 2399, 7157,
-4701, 506, 1180, 507, 621, 6767, 7782, 4545, 4921, 6094, 4922,
-4702, 1360, 1336, 759, 1326, 1705, 7143, 5980, 1707, 1708, 5981,
-4703, 1172, 641, 1164, 1237, 7181, 6261, 2981, 3324, 5571, 3254,
-4704, 301, 134, 133, 99, 7224, 1487, 7222, 3896, 3656, 3655,
-4705, 909, 255, 402, 256, 6983, 4202, 7230, 6648, 3763, 4203,
-4706, 546, 445, 1167, 545, 4667, 5734, 5733, 4669, 4665, 6252,
-4707, 97, 130, 298, 96, 3650, 7343, 3888, 1546, 3649, 3887,
-4708, 1001, 922, 427, 841, 2409, 6578, 6577, 2408, 2223, 7783,
-4709, 1098, 613, 1189, 1195, 6501, 6547, 2972, 3057, 7537, 3058,
-4710, 141, 856, 142, 106, 1940, 1939, 1495, 3670, 7817, 3671,
-4711, 850, 297, 96, 129, 5834, 3885, 5832, 1928, 6025, 3648,
-4712, 532, 996, 1001, 428, 5718, 2411, 6293, 4622, 7819, 7818,
-4713, 285, 842, 429, 284, 7157, 6954, 4285, 3850, 6955, 4284,
-4714, 735, 1336, 1343, 1295, 7457, 1718, 7820, 7454, 3129, 1684,
-4715, 1343, 735, 770, 1336, 7820, 5433, 6969, 1718, 7457, 7814,
-4716, 770, 735, 759, 1336, 5433, 5456, 5463, 7814, 7457, 7143,
-4717, 502, 587, 1188, 620, 4809, 6034, 6074, 4810, 4812, 7587,
-4718, 1375, 107, 78, 839, 6424, 3608, 6504, 6425, 1906, 6505,
-4719, 670, 1304, 711, 665, 7128, 6925, 5216, 5121, 6926, 5215,
-4720, 1287, 731, 722, 1347, 6930, 5294, 7821, 2654, 7284, 7285,
-4721, 722, 1305, 1287, 1347, 7822, 2662, 7821, 7285, 1743, 2654,
-4722, 852, 301, 934, 134, 7223, 7215, 2187, 1931, 7224, 2145,
-4723, 934, 301, 100, 134, 7215, 3897, 7205, 2145, 7224, 3657,
-4724, 8, 146, 7, 224, 3548, 3545, 1500, 3676, 7823, 3677,
-4725, 309, 453, 1016, 344, 4358, 7824, 7518, 4003, 4359, 5835,
-4726, 617, 1257, 1266, 1264, 6629, 3373, 6250, 7227, 2984, 3374,
-4727, 548, 1183, 1158, 495, 6802, 3021, 6572, 4746, 7520, 6573,
-4728, 1363, 744, 1339, 1322, 7743, 6912, 1663, 1687, 7825, 1686,
-4729, 398, 508, 980, 1102, 4547, 6510, 7826, 6990, 6991, 2754,
-4730, 1363, 1356, 744, 1322, 1636, 7614, 7743, 1687, 1688, 7825,
-4731, 109, 281, 921, 840, 7389, 5695, 2117, 1908, 5696, 2118,
-4732, 461, 381, 492, 1128, 4387, 4504, 4503, 6620, 7263, 7827,
-4733, 1001, 841, 428, 996, 2408, 5711, 7818, 2411, 2394, 7819,
-4734, 306, 343, 1011, 937, 4356, 7102, 7103, 6429, 7828, 2435,
-4735, 1028, 873, 351, 872, 2489, 6623, 6565, 2488, 1990, 6590,
-4736, 392, 245, 821, 973, 4172, 7769, 7641, 7453, 7770, 2330,
-4737, 51, 874, 196, 873, 7280, 1991, 7803, 7829, 1993, 1989,
-4738, 492, 1129, 461, 1128, 7502, 6619, 4503, 7827, 2838, 6620,
-4739, 939, 783, 367, 938, 2228, 6882, 6752, 2230, 2227, 6754,
-4740, 1375, 1, 78, 107, 7187, 1527, 6504, 6424, 3607, 3608,
-4741, 1199, 1228, 1130, 579, 3218, 3217, 3194, 6747, 6694, 6696,
-4742, 957, 481, 956, 801, 7242, 5623, 2284, 2282, 5872, 2280,
-4743, 1352, 1372, 1364, 772, 1614, 1613, 1615, 6474, 6475, 6482,
-4744, 1372, 744, 1363, 1356, 7830, 7743, 1630, 1635, 7614, 1636,
-4745, 165, 164, 22, 802, 1400, 3580, 3579, 1813, 1812, 7104,
-4746, 22, 164, 231, 802, 3580, 7195, 3690, 7104, 1812, 7336,
-4747, 393, 246, 978, 904, 4175, 7459, 7719, 7831, 7460, 2441,
-4748, 1361, 766, 779, 1369, 7833, 5478, 7832, 1628, 7834, 7245,
-4749, 779, 766, 767, 1369, 5478, 5471, 5476, 7245, 7834, 7652,
-4750, 1340, 763, 1294, 1338, 5969, 7835, 3261, 1681, 6612, 3213,
-4751, 767, 766, 756, 1369, 5471, 5421, 5453, 7652, 7834, 6284,
-4752, 519, 628, 1194, 1185, 4940, 6143, 6133, 7427, 6142, 3056,
-4753, 416, 1103, 1111, 1061, 7115, 2780, 6167, 7116, 2756, 2777,
-4754, 969, 425, 424, 379, 7050, 4274, 5895, 7344, 4460, 4617,
-4755, 325, 1048, 1049, 893, 6676, 2553, 6610, 7595, 2549, 2551,
-4756, 161, 798, 230, 799, 1801, 6999, 6785, 1803, 1805, 6996,
-4757, 1327, 739, 727, 1344, 6442, 5381, 7836, 1728, 6845, 7837,
-4758, 1056, 503, 504, 393, 7382, 4536, 6588, 7720, 4533, 4534,
-4759, 474, 1152, 1153, 1051, 6597, 2910, 7763, 6418, 2906, 2908,
-4760, 1056, 393, 978, 904, 7720, 7719, 2578, 2576, 7831, 2441,
-4761, 1354, 767, 756, 1369, 6365, 5453, 6282, 1651, 7652, 6284,
-4762, 582, 1121, 1122, 458, 6215, 2817, 7838, 4798, 7211, 6301,
-4763, 384, 1121, 582, 458, 5949, 6215, 4766, 4376, 7211, 4798,
-4764, 902, 39, 184, 819, 7036, 7514, 2077, 2220, 7146, 1863,
-4765, 423, 1159, 528, 422, 5710, 5708, 4612, 4267, 6688, 4611,
-4766, 660, 579, 1199, 647, 5064, 6747, 6865, 5066, 5000, 6559,
-4767, 782, 6, 144, 145, 6793, 3544, 1752, 1753, 3543, 1380,
-4768, 528, 1159, 1096, 1095, 5708, 3005, 5662, 7085, 3163, 2739,
-4769, 55, 878, 56, 200, 7840, 7839, 1579, 7841, 2003, 7842,
-4770, 1287, 722, 714, 1286, 7821, 5255, 7667, 3439, 7844, 7843,
-4771, 422, 1159, 994, 423, 6688, 2932, 6687, 4267, 5710, 6689,
-4772, 681, 1173, 705, 746, 6262, 7845, 5286, 5308, 5853, 5309,
-4773, 265, 831, 989, 988, 7575, 2374, 5578, 6897, 2371, 2375,
-4774, 705, 1155, 1112, 1173, 7846, 2920, 5756, 7845, 2991, 2990,
-4775, 1273, 1236, 747, 1192, 3392, 5556, 5559, 3391, 3252, 5938,
-4776, 1265, 1236, 746, 1273, 3371, 5557, 5852, 3393, 3392, 5558,
-4777, 392, 246, 393, 904, 4173, 4175, 4177, 7642, 7460, 7831,
-4778, 275, 421, 1062, 422, 4260, 6064, 7072, 4262, 4264, 6065,
-4779, 1376, 273, 918, 71, 7024, 7339, 7069, 7025, 3813, 7338,
-4780, 837, 919, 276, 74, 2206, 6026, 7847, 7775, 6027, 3822,
-4781, 917, 835, 1376, 273, 2204, 6964, 6962, 7848, 7340, 7024,
-4782, 330, 454, 367, 938, 4362, 4364, 4114, 6870, 6757, 6754,
-4783, 1145, 576, 551, 1202, 5598, 4770, 7849, 3086, 6486, 7736,
-4784, 814, 236, 969, 813, 5613, 7051, 2319, 1850, 7850, 2318,
-4785, 678, 642, 679, 1237, 5113, 5114, 5116, 5570, 5572, 7310,
-4786, 301, 933, 133, 852, 7851, 2142, 7222, 7223, 2214, 1932,
-4787, 1361, 1357, 766, 1369, 1652, 7046, 7833, 1628, 1653, 7834,
-4788, 561, 1235, 1148, 1147, 6826, 3243, 6727, 6114, 3242, 2895,
-4789, 1100, 1183, 495, 1158, 3053, 7520, 7852, 2943, 3021, 6573,
-4790, 1056, 392, 393, 904, 7384, 4177, 7720, 2576, 7642, 7831,
-4791, 935, 303, 448, 304, 7697, 4341, 6123, 6125, 3907, 4342,
-4792, 1147, 1202, 561, 1235, 3088, 6825, 6114, 3242, 3244, 6826,
-4793, 633, 535, 536, 1155, 4955, 4636, 4956, 7742, 5654, 6354,
-4794, 1144, 602, 1234, 1233, 7401, 7853, 3239, 3237, 7404, 3241,
-4795, 66, 915, 210, 211, 6334, 2103, 7854, 6335, 2102, 1447,
-4796, 352, 873, 1029, 874, 7855, 2491, 7500, 7270, 1993, 2492,
-4797, 65, 915, 66, 268, 6796, 6334, 1589, 3797, 6832, 3798,
-4798, 660, 647, 1199, 1285, 5066, 6559, 6865, 7723, 5538, 3468,
-4799, 506, 621, 505, 1180, 4921, 4816, 4542, 6767, 6094, 6093,
-4800, 833, 915, 268, 66, 2202, 6832, 6830, 6333, 6334, 3798,
-4801, 179, 1375, 142, 237, 6426, 7856, 1858, 5823, 7858, 7857,
-4802, 683, 590, 694, 1242, 5130, 5168, 5184, 7859, 7481, 6104,
-4803, 339, 24, 804, 167, 3984, 5616, 5615, 6759, 3583, 1819,
-4804, 768, 775, 764, 1368, 5489, 5483, 5429, 6264, 6267, 6448,
-4805, 1118, 380, 1119, 599, 7860, 5954, 2808, 7675, 4850, 6166,
-4806, 528, 1096, 584, 1095, 5662, 5648, 4843, 7085, 2739, 5649,
-4807, 483, 1093, 963, 962, 7137, 2724, 7139, 7398, 2723, 2302,
-4808, 965, 964, 568, 1094, 2308, 7861, 5638, 2730, 2729, 5640,
-4809, 833, 66, 268, 269, 6333, 3798, 6830, 6805, 3800, 3802,
-4810, 1298, 645, 682, 659, 6724, 5126, 6786, 6788, 5062, 5127,
-4811, 1218, 1190, 527, 1162, 3178, 6306, 6494, 3177, 3042, 6307,
-4812, 73, 895, 363, 896, 7862, 7798, 4039, 7322, 2059, 7316,
-4813, 418, 525, 1110, 992, 4601, 7357, 5919, 5920, 7359, 2773,
-4814, 845, 289, 119, 926, 7163, 7162, 1918, 2209, 7863, 2127,
-4815, 633, 1191, 681, 655, 6798, 7864, 5124, 5111, 7865, 5123,
-4816, 991, 271, 418, 834, 7217, 4250, 5918, 2380, 6210, 7866,
-4817, 850, 129, 96, 130, 1928, 3648, 5832, 1927, 1483, 3649,
-4818, 544, 443, 1007, 543, 4661, 7174, 7867, 4663, 4660, 7063,
-4819, 857, 179, 34, 839, 1941, 5903, 6051, 2225, 2071, 6427,
-4820, 1089, 1213, 583, 1214, 3140, 7750, 6217, 3143, 3145, 6218,
-4821, 1011, 343, 1012, 937, 7102, 7540, 2439, 2435, 7828, 2438,
-4822, 1199, 1228, 606, 1286, 3218, 6678, 6864, 3483, 3498, 6067,
-4823, 649, 1213, 583, 1089, 6138, 7750, 5025, 6136, 3140, 6217,
-4824, 1229, 1301, 1261, 600, 3496, 3512, 3351, 7868, 7869, 7639,
-4825, 1195, 632, 655, 1191, 6182, 5047, 7870, 3248, 6184, 7865,
-4826, 1200, 1268, 604, 614, 3471, 7871, 7252, 6469, 6470, 5005,
-4827, 1197, 530, 498, 1124, 5656, 4776, 6009, 3065, 6729, 6404,
-4828, 1107, 1193, 621, 1180, 3051, 6092, 7535, 3008, 3052, 6094,
-4829, 430, 533, 429, 998, 4626, 4625, 4289, 7487, 7484, 5715,
-4830, 1101, 1245, 516, 1105, 3295, 7507, 6816, 2762, 3296, 6817,
-4831, 1375, 1, 142, 237, 7187, 3672, 7856, 7858, 3704, 7857,
-4832, 856, 179, 142, 237, 2069, 1858, 1939, 6580, 5823, 7857,
-4833, 446, 1069, 934, 1070, 7371, 2630, 7226, 6872, 2652, 2633,
-4834, 1269, 663, 679, 672, 6857, 5122, 6852, 7585, 5171, 5252,
-4835, 317, 1032, 1033, 877, 7328, 2505, 7327, 7493, 2501, 2503,
-4836, 1169, 546, 642, 643, 6300, 4984, 5727, 6258, 4986, 4988,
-4837, 424, 994, 1097, 423, 5628, 2785, 5627, 4270, 6689, 5723,
-4838, 220, 278, 837, 920, 7873, 7872, 1899, 2113, 5894, 2175,
-4839, 1067, 1172, 1008, 545, 2980, 2970, 2644, 7776, 6253, 7583,
-4840, 813, 236, 969, 379, 7850, 7051, 2318, 5917, 4137, 7344,
-4841, 591, 1245, 1101, 1224, 7508, 3295, 6513, 6976, 3298, 3196,
-4842, 44, 189, 45, 822, 7875, 7874, 1568, 7513, 1870, 6658,
-4843, 118, 288, 844, 926, 7876, 7563, 1915, 2128, 7877, 2179,
-4844, 373, 565, 1085, 577, 4722, 6380, 5621, 4775, 4787, 7810,
-4845, 1306, 667, 650, 1293, 6392, 5082, 7683, 3041, 6744, 6308,
-4846, 831, 265, 1377, 913, 7575, 6710, 7572, 2200, 6713, 6711,
-4847, 829, 204, 1373, 912, 1883, 7250, 7878, 2167, 2097, 6376,
-4848, 358, 886, 1042, 322, 6187, 2530, 7400, 4092, 6190, 7879,
-4849, 650, 1293, 560, 1235, 6308, 6309, 5015, 7880, 3500, 6044,
-4850, 868, 312, 1023, 867, 7590, 5698, 2474, 1975, 6399, 2473,
-4851, 43, 866, 188, 865, 5587, 1967, 5778, 5780, 1969, 1965,
-4852, 650, 560, 561, 1235, 5015, 4710, 5016, 7880, 6044, 6826,
-4853, 463, 1132, 1133, 1031, 5795, 2850, 5945, 5796, 2846, 2848,
-4854, 1266, 1247, 720, 1314, 3375, 6234, 7362, 3268, 3530, 6235,
-4855, 560, 1235, 1293, 1203, 6044, 3500, 6309, 6803, 3247, 3458,
-4856, 1130, 488, 1131, 579, 6695, 7501, 2844, 6696, 4785, 6748,
-4857, 119, 289, 87, 926, 7162, 3860, 3629, 2127, 7863, 7881,
-4858, 507, 1180, 979, 1107, 7782, 3009, 7620, 6016, 3008, 2767,
-4859, 44, 866, 867, 189, 5588, 1972, 6397, 7875, 1968, 1970,
-4860, 492, 1228, 1198, 619, 6677, 3219, 7882, 4914, 6679, 6704,
-4861, 1295, 697, 1281, 1323, 7456, 6357, 3205, 1698, 5672, 3204,
-4862, 1111, 415, 416, 1061, 5516, 4246, 6167, 2777, 5518, 7116,
-4863, 595, 664, 1284, 1217, 5076, 6571, 7883, 6749, 6750, 3440,
-4864, 87, 118, 119, 926, 3628, 1472, 3629, 7881, 2128, 2127,
-4865, 527, 422, 1162, 421, 4609, 6066, 6307, 4608, 4264, 6063,
-4866, 1252, 1246, 748, 708, 3326, 7685, 6784, 6071, 6072, 5347,
-4867, 218, 73, 219, 896, 6097, 6098, 1455, 2057, 7322, 2058,
-4868, 1349, 1368, 764, 774, 1621, 6448, 6447, 7471, 6479, 5450,
-4869, 1329, 763, 777, 754, 6611, 5467, 7288, 7884, 5407, 5468,
-4870, 339, 805, 25, 167, 5496, 7885, 3983, 6759, 1821, 3586,
-4871, 978, 393, 394, 247, 7719, 4180, 7664, 7461, 4176, 4178,
-4872, 231, 481, 957, 801, 4446, 7242, 7241, 5870, 5872, 2282,
-4873, 771, 1366, 778, 751, 6414, 7794, 5475, 5440, 6416, 5470,
-4874, 1298, 1285, 659, 1305, 3469, 7511, 6788, 3089, 3494, 6968,
-4875, 902, 820, 185, 40, 2156, 1866, 2076, 7035, 5902, 5900,
-4876, 1286, 722, 660, 1305, 7844, 5253, 6068, 3493, 7822, 7886,
-4877, 1112, 634, 705, 635, 7468, 5199, 5756, 5926, 4963, 5200,
-4878, 660, 1285, 1286, 1305, 7723, 3484, 6068, 7886, 3494, 3493,
-4879, 660, 722, 659, 1305, 5253, 5256, 5139, 7886, 7822, 6968,
-4880, 506, 395, 1156, 505, 4540, 7815, 6765, 4542, 4538, 6172,
-4881, 659, 1285, 660, 1305, 7511, 7723, 5139, 6968, 3494, 7886,
-4882, 340, 962, 963, 807, 7759, 2302, 7613, 7677, 2298, 2300,
-4883, 1255, 1246, 748, 1252, 3334, 7685, 7378, 3336, 3326, 6784,
-4884, 829, 59, 1373, 204, 7887, 6927, 7878, 1883, 7251, 7250,
-4885, 207, 206, 264, 61, 1443, 6934, 7809, 7888, 6680, 3785,
-4886, 664, 1216, 1282, 1283, 7890, 3430, 7889, 7577, 3431, 3112,
-4887, 596, 1095, 568, 1094, 7084, 5639, 4905, 5527, 2734, 5640,
-4888, 1187, 514, 626, 515, 5933, 4824, 7891, 7490, 4571, 4934,
-4889, 1216, 1215, 612, 1282, 3154, 6842, 7892, 3430, 3425, 7020,
-4890, 1057, 406, 514, 515, 6395, 4567, 5932, 7414, 4569, 4571,
-4891, 572, 1093, 483, 1092, 7554, 7137, 4751, 7555, 2725, 7397,
-4892, 1266, 1257, 617, 656, 3373, 6629, 6250, 5785, 6175, 5051,
-4893, 1195, 655, 646, 1257, 7870, 5050, 7533, 3341, 7893, 6630,
-4894, 1304, 1315, 712, 1314, 1740, 7127, 7129, 1739, 1741, 7894,
-4895, 1110, 523, 1219, 524, 6599, 7702, 3165, 5936, 4600, 7153,
-4896, 199, 877, 54, 200, 2000, 7712, 6768, 1436, 2001, 6769,
-4897, 768, 776, 1351, 739, 5462, 7312, 7311, 5428, 5459, 6441,
-4898, 44, 822, 45, 247, 7513, 6658, 1568, 3734, 6659, 3735,
-4899, 418, 272, 834, 271, 4251, 6209, 7866, 4250, 3811, 6210,
-4900, 1189, 574, 613, 531, 5955, 4897, 6547, 6229, 4803, 4898,
-4901, 879, 202, 56, 201, 2007, 7495, 7895, 2006, 1438, 6331,
-4902, 1238, 683, 743, 1312, 6863, 5331, 7896, 3528, 7753, 7509,
-4903, 111, 283, 282, 922, 7156, 3844, 7155, 2119, 7784, 7165,
-4904, 1327, 773, 1318, 752, 6439, 7897, 1730, 7206, 5443, 7898,
-4905, 142, 1, 106, 237, 3672, 1556, 3671, 7857, 3704, 3703,
-4906, 94, 127, 296, 930, 3644, 6910, 3881, 6961, 2136, 7747,
-4907, 262, 60, 1373, 59, 3780, 6732, 7424, 3779, 1583, 6927,
-4908, 646, 655, 656, 1257, 5050, 5053, 5052, 6630, 7893, 6175,
-4909, 1066, 433, 434, 289, 5815, 4301, 7341, 7899, 4297, 4299,
-4910, 879, 56, 57, 318, 7895, 1580, 7900, 7651, 3937, 3936,
-4911, 656, 1257, 655, 1191, 6175, 7893, 5053, 5787, 3340, 7865,
-4912, 298, 130, 97, 932, 7343, 3650, 3888, 5740, 2141, 7755,
-4913, 655, 1257, 1195, 1191, 7893, 3341, 7870, 7865, 3340, 3248,
-4914, 303, 102, 137, 136, 3903, 3662, 7695, 7696, 3661, 1490,
-4915, 1332, 1349, 737, 1352, 1720, 7470, 7183, 1721, 1633, 6481,
-4916, 1332, 1349, 1341, 733, 1720, 1692, 1732, 7184, 7469, 7548,
-4917, 45, 46, 248, 905, 1569, 3738, 3737, 6657, 6462, 6463,
-4918, 479, 795, 951, 796, 6285, 2264, 7295, 7607, 1796, 2265,
-4919, 870, 47, 869, 192, 6781, 7901, 1981, 1979, 7259, 1977,
-4920, 737, 1349, 1332, 733, 7470, 1720, 7183, 5385, 7469, 7184,
-4921, 769, 1348, 1352, 1370, 7672, 1647, 6472, 6992, 1641, 1627,
-4922, 72, 918, 274, 71, 5536, 6670, 3816, 1595, 7338, 3815,
-4923, 990, 832, 267, 915, 2378, 5549, 7333, 2377, 2170, 6797,
-4924, 67, 211, 66, 889, 7446, 6335, 1590, 7237, 2036, 5819,
-4925, 1352, 1372, 769, 1370, 1614, 6473, 6472, 1627, 1626, 6992,
-4926, 889, 211, 66, 888, 2036, 6335, 5819, 2038, 2034, 5821,
-4927, 664, 1283, 1282, 1316, 7577, 3112, 7889, 7576, 3114, 3113,
-4928, 767, 1371, 779, 1369, 6527, 6525, 5476, 7652, 1631, 7245,
-4929, 833, 211, 67, 212, 1892, 7446, 6800, 1891, 1448, 6801,
-4930, 771, 1367, 738, 1348, 6537, 7902, 5437, 7673, 1640, 6616,
-4931, 1185, 629, 520, 592, 7656, 4943, 6361, 7657, 4942, 4828,
-4932, 1200, 1301, 604, 1268, 3480, 7903, 7252, 3471, 3481, 7871,
-4933, 1353, 1324, 750, 1348, 1697, 7904, 6613, 1660, 1696, 6614,
-4934, 289, 288, 87, 926, 3862, 3858, 3860, 7863, 7877, 7881,
-4935, 6, 223, 144, 5, 3674, 6794, 3544, 1498, 3675, 3541,
-4936, 465, 487, 1035, 1136, 4472, 5505, 7452, 7542, 7578, 2858,
-4937, 930, 93, 94, 126, 7463, 1543, 6961, 2137, 3642, 3643,
-4938, 34, 179, 237, 1375, 5903, 5823, 3705, 6506, 6426, 7858,
-4939, 1189, 531, 613, 532, 6229, 4898, 6547, 5983, 4624, 4949,
-4940, 749, 1251, 692, 755, 7497, 7419, 5349, 5375, 6943, 5373,
-4941, 1022, 348, 1021, 866, 7905, 7092, 2472, 2470, 5589, 2468,
-4942, 553, 1135, 1136, 464, 7387, 2859, 7386, 4686, 7692, 7543,
-4943, 144, 223, 781, 5, 6794, 6046, 1751, 3541, 3675, 5603,
-4944, 880, 355, 319, 1036, 6325, 4089, 5594, 2512, 5504, 7353,
-4945, 1139, 1038, 467, 1037, 2867, 7547, 7906, 2866, 2520, 7907,
-4946, 715, 750, 1321, 769, 5354, 7258, 7257, 5431, 5430, 7908,
-4947, 604, 1301, 1200, 1231, 7903, 3480, 7252, 7808, 3497, 3229,
-4948, 716, 581, 1177, 1279, 5230, 5510, 7909, 7003, 5512, 3415,
-4949, 1373, 205, 912, 204, 6375, 2096, 6376, 7250, 1441, 2097,
-4950, 320, 882, 1038, 883, 7138, 2518, 7910, 6673, 2020, 2519,
-4951, 1039, 883, 320, 1038, 2521, 6673, 7911, 2523, 2519, 7910,
-4952, 1095, 528, 596, 584, 7085, 4840, 7084, 5649, 4843, 4842,
-4953, 320, 467, 490, 1038, 4403, 4485, 4484, 7910, 7547, 7546,
-4954, 535, 1063, 1064, 1157, 5910, 2613, 5653, 5655, 2945, 2994,
-4955, 837, 277, 276, 994, 7221, 3826, 7847, 2388, 7154, 7912,
-4956, 1325, 1279, 676, 716, 3429, 6508, 6507, 6734, 7003, 5229,
-4957, 1038, 882, 356, 1037, 2518, 7298, 7913, 2520, 2516, 7235,
-4958, 1325, 716, 676, 719, 6734, 5229, 6507, 6736, 5240, 5239,
-4959, 1085, 1212, 1084, 577, 3133, 3132, 2701, 7810, 6718, 7793,
-4960, 1178, 1212, 1085, 611, 3136, 3133, 3135, 5909, 6382, 6381,
-4961, 848, 930, 295, 1003, 2183, 7462, 7464, 2414, 2627, 7914,
-4962, 866, 311, 43, 348, 7682, 3922, 5587, 5589, 4058, 4009,
-4963, 633, 1155, 536, 634, 7742, 6354, 4956, 4960, 7478, 4958,
-4964, 1375, 179, 142, 3, 6426, 1858, 7856, 6763, 1415, 1496,
-4965, 1154, 456, 999, 1014, 5790, 7193, 2914, 2911, 6116, 2792,
-4966, 34, 839, 78, 280, 6427, 6505, 3833, 3963, 6353, 3834,
-4967, 440, 1003, 930, 849, 7498, 2627, 7754, 6907, 2580, 2211,
-4968, 1079, 946, 947, 477, 2675, 2254, 2676, 7915, 7917, 7916,
-4969, 1020, 311, 1021, 458, 6088, 7093, 2469, 6086, 4374, 6302,
-4970, 229, 335, 479, 796, 4076, 4443, 4442, 7918, 7606, 7607,
-4971, 581, 1279, 716, 676, 5512, 7003, 5230, 5110, 6508, 5229,
-4972, 154, 227, 792, 791, 7499, 6790, 1782, 1780, 6101, 1784,
-4973, 420, 835, 992, 419, 7057, 2384, 6914, 4258, 7762, 7617,
-4974, 650, 1235, 561, 1290, 7880, 6826, 5016, 7684, 3503, 6827,
-4975, 891, 68, 214, 69, 7919, 6783, 2043, 7920, 1592, 7079,
-4976, 87, 288, 118, 926, 3858, 7876, 3628, 7881, 7877, 2128,
-4977, 198, 909, 199, 256, 2091, 2090, 1435, 7716, 6648, 6407,
-4978, 823, 250, 396, 906, 7042, 4185, 7921, 2161, 7021, 6546,
-4979, 494, 1090, 583, 571, 5530, 6216, 4800, 4795, 7313, 4799,
-4980, 1373, 60, 830, 205, 6732, 5688, 6374, 6375, 6649, 1886,
-4981, 404, 827, 910, 984, 5977, 2165, 5498, 5499, 2361, 2360,
-4982, 398, 1102, 980, 981, 6990, 2754, 7826, 7922, 2753, 2353,
-4983, 198, 256, 54, 53, 7716, 3762, 7714, 6451, 3761, 1577,
-4984, 869, 47, 870, 313, 7901, 6781, 1981, 7634, 3926, 6782,
-4985, 1238, 743, 1300, 1312, 7896, 6815, 3478, 3528, 7509, 3379,
-4986, 384, 347, 1020, 458, 4150, 6087, 5951, 4376, 4375, 6086,
-4987, 1198, 1127, 1128, 566, 3211, 2835, 3070, 6703, 7630, 7638,
-4988, 622, 1179, 1251, 1193, 7345, 3319, 7420, 7346, 3176, 3320,
-4989, 1253, 689, 691, 589, 7123, 5259, 7599, 7124, 5154, 5157,
-4990, 413, 267, 914, 266, 4236, 5548, 5546, 4235, 3796, 5582,
-4991, 414, 520, 1055, 521, 4588, 7725, 5857, 4589, 4591, 7923,
-4992, 1320, 1306, 704, 1335, 3232, 6203, 6372, 1616, 3357, 6205,
-4993, 726, 689, 1297, 1289, 5272, 6595, 6594, 7364, 7365, 3192,
-4994, 726, 1289, 745, 700, 7364, 7924, 5338, 5271, 7278, 5337,
-4995, 856, 105, 141, 937, 7925, 3669, 1940, 2218, 7926, 2150,
-4996, 1302, 1267, 648, 1296, 3487, 6489, 6487, 3486, 3465, 7505,
-4997, 1174, 512, 625, 513, 6458, 4931, 7524, 7472, 4564, 4932,
-4998, 55, 257, 54, 200, 3765, 3764, 1578, 7841, 5984, 6769,
-4999, 1079, 598, 369, 1080, 6389, 4848, 7927, 2680, 6900, 7928,
-5000, 1081, 948, 369, 1080, 2681, 6438, 6437, 2683, 2679, 7928,
-5001, 624, 1238, 693, 623, 6848, 6862, 5167, 4930, 6847, 5166,
-5002, 1290, 685, 1272, 618, 7741, 7249, 3452, 7929, 5136, 6904,
-5003, 1287, 722, 1286, 1305, 7821, 7844, 3439, 2662, 7822, 3493,
-5004, 880, 355, 318, 57, 6325, 4065, 7650, 6326, 4023, 3936,
-5005, 470, 322, 1043, 359, 4412, 7745, 6715, 4411, 4069, 7624,
-5006, 1042, 887, 1043, 322, 2531, 2533, 2535, 7879, 6191, 7745,
-5007, 879, 202, 880, 57, 2007, 2009, 2011, 7900, 6242, 6326,
-5008, 1217, 1094, 1218, 596, 3158, 3160, 3162, 5528, 5527, 6496,
-5009, 595, 1217, 1284, 1190, 6749, 3440, 7883, 6053, 3433, 3441,
-5010, 1136, 1135, 1034, 464, 2859, 2855, 2857, 7543, 7692, 7707,
-5011, 657, 1301, 604, 600, 7930, 7903, 5055, 5056, 7869, 4868,
-5012, 1306, 1290, 650, 685, 3040, 7684, 7683, 6204, 7741, 5135,
-5013, 276, 1062, 275, 919, 7931, 7072, 3823, 6026, 2605, 7261,
-5014, 887, 65, 359, 322, 7449, 4031, 7448, 6191, 3944, 4069,
-5015, 553, 1229, 1301, 1231, 7933, 3496, 7932, 7385, 3221, 3497,
-5016, 887, 322, 359, 1043, 6191, 4069, 7448, 2533, 7745, 7624,
-5017, 600, 1301, 604, 553, 7869, 7903, 4868, 4852, 7932, 4867,
-5018, 668, 684, 648, 1267, 5133, 5132, 5083, 6490, 7733, 6489,
-5019, 713, 732, 756, 1345, 5300, 5378, 5380, 7018, 7935, 7934,
-5020, 1042, 322, 1043, 486, 7879, 7745, 2535, 7936, 4468, 6716,
-5021, 771, 1370, 769, 778, 7674, 6992, 5436, 5475, 6993, 5474,
-5022, 253, 982, 825, 908, 5761, 2356, 6719, 7937, 2355, 2163,
-5023, 737, 774, 1364, 1349, 5448, 6485, 6480, 7470, 7471, 1623,
-5024, 278, 220, 837, 75, 7873, 1899, 7872, 3827, 7120, 7121,
-5025, 1057, 515, 514, 1187, 7414, 4571, 5932, 3030, 7490, 5933,
-5026, 518, 591, 1101, 1194, 4938, 6513, 5826, 6135, 6607, 3055,
-5027, 769, 1352, 737, 772, 6472, 6481, 5434, 5438, 6474, 5439,
-5028, 1220, 709, 1240, 678, 6152, 6153, 3277, 6368, 5234, 6287,
-5029, 1000, 1171, 538, 1054, 2978, 6312, 7373, 2570, 2979, 6311,
-5030, 221, 278, 220, 920, 6860, 7873, 1457, 2112, 5894, 2113,
-5031, 220, 278, 221, 75, 7873, 6860, 1457, 7120, 3827, 7729,
-5032, 1324, 668, 721, 725, 6550, 5282, 6549, 6634, 5268, 5283,
-5033, 60, 206, 830, 205, 5689, 1885, 5688, 6649, 1442, 1886,
-5034, 1055, 1182, 1111, 521, 3017, 3019, 2779, 7923, 7148, 6822,
-5035, 1343, 756, 1330, 1357, 6970, 7938, 1678, 1672, 6283, 1679,
-5036, 1302, 1324, 668, 1313, 3522, 6550, 6488, 3523, 3201, 6551,
-5037, 1133, 1132, 463, 564, 2850, 5795, 5945, 6965, 5974, 4718,
-5038, 837, 277, 75, 74, 7221, 3825, 7121, 7775, 3824, 1598,
-5039, 757, 764, 1365, 768, 5411, 6932, 6435, 5427, 5429, 6265,
-5040, 671, 1345, 1277, 1309, 7016, 2697, 5560, 6292, 1747, 2968,
-5041, 1334, 760, 702, 743, 6973, 5395, 6003, 6974, 5394, 5364,
-5042, 318, 354, 1034, 879, 4088, 7528, 7767, 7651, 7529, 2507,
-5043, 701, 744, 724, 1322, 5335, 5334, 5333, 7939, 7825, 7626,
-5044, 731, 1347, 757, 728, 7284, 6556, 5382, 5372, 7286, 5384,
-5045, 1309, 1323, 723, 729, 3412, 5673, 6391, 6497, 5928, 5313,
-5046, 604, 1301, 1231, 553, 7903, 3497, 7808, 4867, 7932, 7385,
-5047, 657, 1301, 1303, 1268, 7930, 3489, 7940, 7941, 3481, 3490,
-5048, 971, 838, 279, 816, 2326, 6823, 6869, 2325, 1903, 6121,
-5049, 746, 1273, 747, 752, 5558, 5559, 5342, 5362, 6901, 5403,
-5050, 712, 1344, 1304, 1314, 7942, 2728, 7129, 7894, 2727, 1739,
-5051, 386, 495, 385, 1158, 4793, 4511, 4156, 7592, 6573, 7596,
-5052, 451, 1018, 1120, 1019, 7569, 2809, 5942, 7265, 2463, 2810,
-5053, 451, 578, 1120, 1119, 4777, 5944, 5942, 5952, 5953, 2811,
-5054, 287, 431, 286, 843, 4291, 4290, 3856, 6960, 7071, 5882,
-5055, 276, 277, 837, 74, 3826, 7221, 7847, 3822, 3824, 7775,
-5056, 657, 1301, 600, 1303, 7930, 7869, 5056, 7940, 3489, 7943,
-5057, 1315, 654, 1264, 608, 7233, 7228, 3532, 6057, 5038, 6011,
-5058, 1220, 640, 1186, 709, 6370, 6518, 3169, 6152, 5212, 6151,
-5059, 1329, 1300, 1297, 754, 3125, 3427, 3130, 7884, 7944, 6606,
-5060, 780, 1329, 758, 1334, 7287, 7945, 5486, 6521, 1709, 6972,
-5061, 287, 117, 86, 288, 7946, 3626, 3855, 3859, 7562, 3857,
-5062, 514, 1106, 1187, 1223, 5934, 3031, 5933, 6150, 3186, 3257,
-5063, 1116, 512, 401, 511, 6459, 4558, 7438, 5513, 4560, 4556,
-5064, 1256, 1289, 688, 700, 3449, 7377, 7605, 7276, 7278, 5183,
-5065, 483, 962, 340, 233, 7398, 7759, 4451, 4452, 7812, 4053,
-5066, 1312, 1311, 694, 702, 3529, 5985, 7947, 6004, 5986, 5190,
-5067, 445, 1008, 933, 852, 7173, 2429, 7172, 7948, 2428, 2214,
-5068, 166, 804, 232, 24, 1818, 5614, 5650, 3584, 5616, 3692,
-5069, 1361, 1369, 779, 1367, 1628, 7245, 7832, 1619, 1629, 6538,
-5070, 209, 267, 210, 64, 6671, 6672, 1446, 7670, 3794, 7669,
-5071, 759, 1325, 1326, 1336, 7142, 3270, 5981, 7143, 3271, 1708,
-5072, 445, 852, 933, 301, 7948, 2214, 7172, 4333, 7223, 7851,
-5073, 358, 469, 1041, 321, 4407, 6015, 7399, 4068, 4408, 7351,
-5074, 933, 98, 851, 300, 7950, 7949, 2186, 7479, 3893, 7951,
-5075, 98, 933, 851, 132, 7950, 2186, 7949, 3653, 2143, 1929,
-5076, 364, 1053, 1013, 898, 5636, 2565, 6060, 5842, 2564, 2445,
-5077, 444, 299, 851, 443, 4329, 6896, 5767, 4331, 4327, 6895,
-5078, 339, 805, 961, 233, 5496, 2294, 5495, 4080, 7952, 7811,
-5079, 758, 1300, 749, 755, 6814, 7629, 5452, 5388, 6813, 5375,
-5080, 250, 906, 47, 48, 7021, 7041, 3743, 3744, 7953, 1571,
-5081, 1302, 1296, 648, 614, 3486, 7505, 6487, 6774, 6471, 5008,
-5082, 45, 867, 868, 190, 6398, 1975, 6772, 6775, 1971, 1973,
-5083, 351, 315, 1028, 461, 4085, 5998, 6565, 4385, 4388, 6566,
-5084, 394, 248, 978, 247, 4179, 7954, 7664, 4178, 3739, 7461,
-5085, 47, 46, 823, 249, 1570, 6461, 7040, 3741, 3740, 6751,
-5086, 1297, 1300, 749, 754, 3427, 7629, 7597, 6606, 7944, 5447,
-5087, 1308, 1339, 1310, 701, 3225, 3150, 3224, 6274, 6911, 7955,
-5088, 230, 953, 954, 798, 5606, 2275, 5604, 6999, 2271, 2273,
-5089, 1309, 1345, 1330, 732, 1747, 1682, 1748, 6500, 7935, 6499,
-5090, 1361, 753, 779, 766, 7737, 5484, 7832, 7833, 5422, 5478,
-5091, 17, 157, 795, 158, 3568, 1791, 6231, 3567, 1393, 1792,
-5092, 465, 464, 1034, 354, 4398, 7707, 7708, 4397, 4394, 7528,
-5093, 572, 1092, 483, 376, 7555, 7397, 4751, 4752, 7609, 4498,
-5094, 758, 1334, 1329, 1300, 6972, 1709, 7945, 6814, 3124, 3125,
-5095, 743, 1334, 758, 1300, 6974, 6972, 5389, 6815, 3124, 6814,
-5096, 771, 1367, 1370, 1366, 6537, 1612, 7674, 6414, 1611, 1607,
-5097, 12, 13, 152, 790, 1505, 3559, 3556, 7795, 5693, 1776,
-5098, 1263, 666, 1288, 597, 6359, 6746, 1745, 7785, 5100, 6745,
-5099, 698, 1331, 1313, 721, 6582, 3202, 6581, 5249, 6554, 6552,
-5100, 1051, 896, 363, 895, 2558, 7316, 6419, 2557, 2059, 7798,
-5101, 669, 1281, 1316, 1282, 6049, 3502, 7738, 6048, 3426, 3113,
-5102, 18, 17, 229, 159, 1510, 3687, 3686, 3571, 3569, 6593,
-5103, 792, 369, 227, 334, 6791, 4118, 6790, 7083, 4117, 4047,
-5104, 1304, 1292, 670, 1315, 3491, 6056, 7128, 1740, 3533, 6055,
-5105, 1022, 312, 866, 867, 6090, 7956, 2470, 2471, 6399, 1972,
-5106, 1319, 1358, 760, 1334, 1711, 6465, 6464, 1712, 1674, 6973,
-5107, 483, 376, 961, 233, 4498, 5602, 7396, 4452, 4131, 7811,
-5108, 1266, 654, 1264, 1315, 6251, 7228, 3374, 3269, 7233, 3532,
-5109, 484, 808, 964, 809, 7141, 2303, 7006, 6318, 1835, 2304,
-5110, 391, 973, 975, 244, 7391, 2336, 7957, 4169, 6214, 6212,
-5111, 339, 233, 25, 805, 4080, 3695, 3983, 5496, 7952, 7885,
-5112, 697, 1323, 1316, 1281, 5672, 3476, 5670, 6357, 3204, 3502,
-5113, 1100, 499, 1184, 500, 7958, 5682, 3024, 7517, 4523, 6843,
-5114, 791, 13, 227, 333, 5692, 3683, 6101, 7687, 3971, 4099,
-5115, 1112, 1171, 706, 1236, 2988, 7959, 5754, 3250, 3249, 5755,
-5116, 723, 729, 1323, 697, 5313, 5928, 5673, 5320, 5386, 5672,
-5117, 1042, 486, 1143, 469, 7936, 7960, 2879, 6029, 4469, 6014,
-5118, 1340, 1270, 745, 1289, 3208, 6811, 5970, 3193, 3207, 7924,
-5119, 782, 6, 330, 223, 6793, 3965, 5854, 5855, 3674, 3999,
-5120, 469, 322, 1042, 486, 4410, 7879, 6029, 4469, 4468, 7936,
-5121, 625, 512, 1174, 590, 4931, 6458, 7524, 4933, 4822, 6457,
-5122, 1252, 709, 1186, 708, 6248, 6151, 3325, 6071, 5213, 6070,
-5123, 782, 223, 1013, 781, 5855, 5850, 2444, 1754, 6046, 2443,
-5124, 697, 1281, 1316, 669, 6357, 3502, 5670, 5250, 6049, 7738,
-5125, 1143, 557, 469, 486, 6886, 4694, 6014, 7960, 4696, 4469,
-5126, 1144, 486, 602, 557, 7354, 4859, 7401, 7403, 4696, 4860,
-5127, 308, 1015, 452, 344, 6558, 5534, 4355, 3997, 5836, 4354,
-5128, 232, 482, 375, 959, 4448, 4465, 4130, 7961, 6165, 5523,
-5129, 661, 645, 682, 1298, 5068, 5126, 5128, 6723, 6724, 6786,
-5130, 1303, 675, 657, 1302, 7962, 5103, 7940, 3531, 5988, 7752,
-5131, 451, 380, 1119, 1018, 4352, 5954, 5952, 7569, 7097, 2807,
-5132, 295, 930, 440, 1003, 7462, 7754, 4317, 7914, 2627, 7498,
-5133, 50, 195, 194, 351, 6626, 1431, 7330, 4014, 6624, 7632,
-5134, 366, 575, 1075, 563, 4760, 5892, 7963, 4715, 4761, 5931,
-5135, 1163, 974, 1100, 500, 2960, 2748, 2961, 6023, 6024, 7517,
-5136, 309, 1017, 380, 346, 7212, 7096, 4140, 4056, 7964, 4139,
-5137, 368, 1078, 946, 945, 5585, 2673, 7965, 5744, 2672, 2251,
-5138, 370, 1126, 459, 1025, 7648, 7319, 4380, 7966, 2828, 7530,
-5139, 945, 790, 946, 333, 2247, 2249, 2251, 7967, 7686, 7968,
-5140, 1286, 722, 714, 687, 7844, 5255, 7843, 6069, 5254, 5225,
-5141, 441, 849, 931, 1006, 6908, 2184, 5564, 6224, 2425, 2424,
-5142, 368, 945, 946, 333, 5744, 2251, 7965, 4115, 7967, 7968,
-5143, 757, 1350, 1362, 1347, 6436, 1643, 6933, 6556, 1669, 1670,
-5144, 946, 333, 227, 477, 7968, 4099, 6099, 7917, 4431, 4430,
-5145, 208, 885, 207, 62, 2025, 2024, 1444, 7623, 7281, 7622,
-5146, 987, 913, 264, 988, 2369, 6712, 7185, 2597, 2372, 6898,
-5147, 946, 333, 791, 227, 7968, 7687, 2250, 6099, 4099, 6101,
-5148, 414, 413, 1055, 520, 4240, 5858, 5857, 4588, 4586, 7725,
-5149, 987, 517, 409, 1060, 5592, 4576, 5885, 2647, 5593, 5814,
-5150, 411, 987, 264, 988, 7969, 7185, 4229, 6892, 2597, 6898,
-5151, 264, 410, 263, 830, 4227, 4226, 3787, 6935, 5922, 5691,
-5152, 791, 333, 946, 790, 7687, 7968, 2250, 1781, 7686, 2249,
-5153, 1118, 453, 380, 599, 7970, 4361, 7860, 7675, 4851, 4850,
-5154, 1263, 1203, 1204, 554, 3360, 3095, 3361, 7971, 7662, 7734,
-5155, 56, 354, 879, 878, 4020, 7529, 7895, 7839, 7527, 2008,
-5156, 527, 1162, 526, 421, 6307, 5721, 4610, 4608, 6063, 4606,
-5157, 248, 1058, 978, 905, 6755, 2587, 7954, 6463, 2586, 2345,
-5158, 260, 57, 202, 828, 3773, 6242, 5550, 6103, 6328, 1881,
-5159, 991, 1110, 417, 1103, 2774, 5935, 7621, 2755, 2775, 6600,
-5160, 1276, 607, 1211, 662, 5994, 6198, 3403, 7791, 5071, 6200,
-5161, 837, 277, 424, 278, 7221, 4268, 6332, 7872, 3829, 4269,
-5162, 935, 137, 304, 854, 2146, 7972, 6125, 2216, 1936, 6126,
-5163, 363, 326, 474, 1051, 4073, 4423, 4422, 6419, 7262, 6418,
-5164, 942, 563, 382, 366, 7973, 4716, 7112, 5887, 4715, 4145,
-5165, 467, 1038, 356, 1037, 7547, 7913, 4404, 7907, 2520, 7235,
-5166, 571, 1091, 572, 376, 7975, 7974, 4794, 4747, 7610, 4752,
-5167, 260, 828, 202, 911, 6103, 1881, 5550, 5551, 2166, 2095,
-5168, 218, 217, 836, 72, 1454, 1898, 1897, 7198, 5537, 6669,
-5169, 491, 1047, 1046, 1148, 7976, 2547, 7756, 6728, 2894, 2893,
-5170, 419, 917, 273, 835, 7977, 7848, 4254, 7762, 2204, 7340,
-5171, 1, 1375, 142, 3, 7187, 7856, 3672, 3606, 6763, 1496,
-5172, 613, 1195, 1098, 632, 7537, 3057, 6501, 4954, 6182, 6503,
-5173, 1192, 706, 747, 707, 5799, 5343, 5938, 5800, 5206, 5344,
-5174, 854, 137, 304, 138, 1936, 7972, 6126, 1935, 1491, 7694,
-5175, 856, 106, 141, 105, 7817, 3670, 1940, 7925, 1555, 3669,
-5176, 490, 1039, 320, 1038, 7564, 7911, 4484, 7546, 2523, 7910,
-5177, 936, 854, 304, 138, 2189, 6126, 7705, 2149, 1935, 7694,
-5178, 295, 93, 94, 930, 3878, 1543, 3879, 7462, 7463, 6961,
-5179, 428, 841, 923, 996, 5711, 2176, 5764, 7819, 2394, 2393,
-5180, 1226, 498, 1123, 1124, 6810, 6403, 3203, 3206, 6404, 2823,
-5181, 139, 103, 305, 104, 3665, 3908, 7978, 3666, 1553, 3909,
-5182, 1056, 973, 392, 904, 2577, 7453, 7384, 2576, 2340, 7642,
-5183, 769, 750, 1321, 1348, 5430, 7258, 7908, 7672, 6614, 1722,
-5184, 56, 354, 318, 879, 4020, 4088, 3937, 7895, 7529, 7651,
-5185, 121, 90, 89, 291, 3634, 1539, 3633, 7027, 3867, 3866,
-5186, 452, 1016, 1117, 453, 5533, 2802, 5532, 4360, 7824, 7800,
-5187, 924, 842, 285, 114, 2177, 7157, 6771, 2124, 1911, 6168,
-5188, 698, 1272, 1307, 1317, 5777, 3366, 5775, 6583, 3368, 3367,
-5189, 897, 327, 364, 1053, 7306, 4074, 5841, 2563, 5635, 5636,
-5190, 834, 916, 271, 68, 2203, 7218, 6210, 6271, 6197, 3806,
-5191, 64, 322, 886, 358, 3945, 6190, 6186, 4028, 4092, 6187,
-5192, 305, 104, 855, 139, 3909, 6945, 7979, 7978, 3666, 1938,
-5193, 917, 273, 1376, 70, 7848, 7024, 6962, 7067, 3812, 7026,
-5194, 1017, 453, 1118, 1016, 7213, 7970, 2804, 2457, 7824, 2803,
-5195, 450, 1011, 385, 1158, 7101, 7541, 4462, 6574, 2929, 7596,
-5196, 139, 138, 936, 103, 1492, 2149, 2148, 3665, 3664, 7980,
-5197, 1117, 1016, 1118, 453, 2802, 2803, 2805, 7800, 7824, 7970,
-5198, 1295, 1280, 1281, 697, 3422, 3445, 3205, 7456, 6356, 6357,
-5199, 309, 453, 1017, 1016, 4358, 7213, 7212, 7518, 7824, 2457,
-5200, 1101, 1105, 517, 1060, 2762, 6707, 5591, 2751, 2759, 5593,
-5201, 405, 985, 406, 1106, 6109, 6110, 4216, 6644, 2763, 6396,
-5202, 936, 138, 304, 103, 2149, 7694, 7705, 7980, 3664, 3906,
-5203, 56, 202, 828, 201, 7495, 1881, 6330, 6331, 1438, 1882,
-5204, 1189, 613, 1098, 532, 6547, 6501, 2972, 5983, 4949, 5982,
-5205, 287, 116, 86, 117, 6959, 3625, 3855, 7946, 1470, 3626,
-5206, 86, 116, 287, 85, 3625, 6959, 3855, 1535, 3624, 3854,
-5207, 305, 855, 936, 139, 7979, 2217, 7189, 7978, 1938, 2148,
-5208, 380, 453, 1118, 1017, 4361, 7970, 7860, 7096, 7213, 2804,
-5209, 99, 300, 98, 933, 3894, 3893, 1548, 6887, 7479, 7950,
-5210, 1263, 1203, 554, 597, 3360, 7662, 7971, 7785, 7786, 4844,
-5211, 1167, 445, 1008, 545, 5734, 7173, 2958, 6252, 4665, 7583,
-5212, 99, 98, 132, 933, 1548, 3653, 3654, 6887, 7950, 2143,
-5213, 1220, 640, 1164, 1168, 6370, 7981, 3167, 3168, 6520, 2964,
-5214, 127, 849, 296, 930, 1926, 6909, 6910, 2136, 2211, 7747,
-5215, 735, 1323, 1330, 729, 5927, 1699, 7982, 5315, 5928, 6498,
-5216, 1221, 525, 526, 1108, 7150, 4607, 7983, 3179, 7358, 5719,
-5217, 10, 332, 787, 225, 3969, 7984, 7080, 3678, 4045, 7081,
-5218, 122, 123, 292, 928, 1476, 7709, 7355, 2133, 2132, 7711,
-5219, 1221, 1108, 526, 1190, 3179, 5719, 7983, 3182, 3043, 5720,
-5220, 563, 940, 382, 478, 5645, 7406, 4716, 4781, 5773, 4438,
-5221, 17, 158, 795, 796, 3567, 1792, 6231, 7985, 1794, 1796,
-5222, 902, 977, 242, 974, 2342, 6888, 7034, 2332, 2343, 5677,
-5223, 1288, 666, 667, 597, 6746, 5101, 6743, 6745, 5100, 5081,
-5224, 940, 563, 1073, 478, 5645, 5644, 2657, 5773, 4781, 7644,
-5225, 331, 786, 148, 785, 7089, 1764, 7394, 5669, 1766, 1762,
-5226, 229, 796, 952, 797, 7918, 2267, 6741, 6592, 1799, 2268,
-5227, 18, 797, 229, 336, 6591, 6592, 3686, 3978, 7065, 4049,
-5228, 1221, 1190, 526, 631, 3182, 5720, 7983, 7151, 6054, 4835,
-5229, 967, 235, 485, 378, 6038, 4458, 7337, 7022, 4135, 4496,
-5230, 584, 1096, 485, 967, 5648, 6202, 4801, 5647, 2737, 7337,
-5231, 340, 963, 483, 377, 7613, 7139, 4451, 4134, 7140, 4501,
-5232, 485, 812, 342, 235, 7986, 6722, 4457, 4458, 7300, 4055,
-5233, 549, 372, 496, 1083, 4678, 4724, 4725, 6337, 7416, 6339,
-5234, 259, 828, 56, 57, 6327, 6330, 3770, 3771, 6328, 1580,
-5235, 466, 1036, 355, 487, 7352, 5504, 4401, 4473, 5506, 4471,
-5236, 1197, 498, 1226, 1124, 6009, 6810, 3258, 3065, 6404, 3206,
-5237, 1313, 684, 668, 1267, 7731, 5133, 6551, 1733, 7733, 6490,
-5238, 27, 26, 340, 170, 1519, 3986, 3985, 3591, 3589, 7987,
-5239, 985, 406, 260, 259, 6110, 4215, 6102, 6111, 4214, 3775,
-5240, 550, 604, 1231, 487, 4869, 7808, 7134, 4783, 4866, 7579,
-5241, 1074, 940, 941, 563, 2658, 2236, 2659, 5646, 5645, 7407,
-5242, 395, 394, 1156, 505, 4183, 6174, 7815, 4538, 4537, 6172,
-5243, 921, 79, 108, 280, 7749, 3610, 2115, 6636, 3835, 6635,
-5244, 293, 92, 294, 929, 3873, 3875, 3877, 7374, 6938, 6937,
-5245, 1158, 997, 387, 1100, 2931, 7593, 7591, 2943, 2786, 7688,
-5246, 942, 563, 1074, 941, 7973, 5646, 2661, 2239, 7407, 2659,
-5247, 1358, 1334, 780, 760, 1674, 6521, 6405, 6465, 6973, 5487,
-5248, 636, 635, 538, 1171, 4966, 4962, 4964, 6762, 6305, 6312,
-5249, 1011, 855, 306, 937, 2436, 6430, 7103, 2435, 2190, 6429,
-5250, 63, 885, 208, 62, 7291, 2025, 7722, 1586, 7281, 7623,
-5251, 690, 740, 1299, 674, 5186, 7409, 7680, 5160, 5220, 7410,
-5252, 356, 466, 467, 1037, 4402, 4477, 4404, 7235, 7236, 7907,
-5253, 847, 292, 437, 293, 7710, 4308, 6838, 7381, 3874, 4309,
-5254, 539, 1171, 1000, 1170, 7594, 2978, 7087, 7131, 2987, 2976,
-5255, 1017, 861, 309, 1016, 2455, 6145, 7212, 2457, 2453, 7518,
-5256, 746, 1173, 705, 1236, 5853, 7845, 5309, 5557, 3251, 5757,
-5257, 1266, 654, 617, 1264, 6251, 5039, 6250, 3374, 7228, 7227,
-5258, 110, 840, 282, 80, 1907, 7166, 7164, 3613, 7390, 3839,
-5259, 110, 80, 282, 81, 3613, 3839, 7164, 3614, 1530, 3840,
-5260, 281, 80, 282, 840, 3837, 3839, 3841, 5696, 7390, 7166,
-5261, 109, 840, 110, 80, 1908, 1907, 1463, 3612, 7390, 3613,
-5262, 293, 929, 847, 124, 7374, 2182, 7381, 7789, 2135, 1921,
-5263, 550, 487, 1231, 1137, 4783, 7579, 7134, 7135, 7299, 3226,
-5264, 1329, 1334, 780, 1359, 1709, 6521, 7287, 1677, 1675, 6406,
-5265, 829, 912, 1373, 262, 2167, 6376, 7878, 7772, 7425, 7424,
-5266, 55, 877, 878, 200, 7988, 2005, 7840, 7841, 2001, 2003,
-5267, 192, 823, 46, 191, 1871, 6461, 7989, 1428, 1872, 7990,
-5268, 853, 302, 303, 101, 7992, 3904, 7991, 7180, 3900, 3902,
-5269, 582, 498, 1122, 1226, 4855, 7601, 7838, 6809, 6810, 3064,
-5270, 43, 311, 866, 865, 3922, 7682, 5587, 5780, 7292, 1969,
-5271, 1122, 498, 1123, 1226, 7601, 6403, 2820, 3064, 6810, 3203,
-5272, 1358, 760, 780, 775, 6465, 5487, 6405, 6268, 5457, 5491,
-5273, 1303, 1302, 1321, 675, 3531, 3521, 1736, 7962, 5988, 5987,
-5274, 1033, 464, 1134, 489, 7691, 6535, 2852, 7329, 4482, 5958,
-5275, 985, 911, 260, 1057, 2365, 5551, 6102, 2582, 2581, 7993,
-5276, 1134, 564, 1133, 489, 7637, 6965, 2853, 5958, 4717, 5947,
-5277, 260, 829, 203, 58, 6760, 1884, 5552, 3774, 7994, 6171,
-5278, 835, 215, 1376, 216, 1896, 6963, 6964, 1895, 1452, 7070,
-5279, 213, 916, 67, 212, 2104, 6195, 7995, 1449, 2105, 6801,
-5280, 685, 1290, 650, 618, 7741, 7684, 5135, 5136, 7929, 5017,
-5281, 303, 136, 853, 101, 7696, 1933, 7991, 3902, 3660, 7180,
-5282, 293, 123, 91, 124, 7788, 3637, 3872, 7789, 1477, 3638,
-5283, 472, 1149, 1150, 1048, 7433, 2901, 7581, 6675, 2897, 2899,
-5284, 382, 563, 942, 941, 4716, 7973, 7112, 7098, 7407, 2239,
-5285, 537, 435, 1054, 1065, 4639, 7175, 7368, 6420, 6421, 2615,
-5286, 789, 788, 151, 226, 1775, 1771, 1773, 7082, 6030, 7996,
-5287, 86, 117, 118, 288, 3626, 1471, 3627, 3857, 7562, 7876,
-5288, 151, 788, 11, 226, 1771, 7668, 3554, 7996, 6030, 3681,
-5289, 1112, 1054, 537, 635, 2782, 7368, 7467, 5926, 6304, 4961,
-5290, 55, 354, 56, 878, 4021, 4020, 1579, 7840, 7527, 7839,
-5291, 923, 112, 284, 113, 2122, 7293, 5765, 2121, 1466, 7774,
-5292, 331, 940, 941, 785, 5772, 2236, 7099, 5669, 2232, 2234,
-5293, 957, 956, 562, 1087, 2284, 6917, 6129, 2706, 2705, 6131,
-5294, 11, 226, 788, 332, 3681, 6030, 7668, 3968, 3970, 6031,
-5295, 1077, 1076, 573, 1208, 2671, 7998, 7997, 3109, 3108, 7999,
-5296, 294, 92, 93, 125, 3875, 1542, 3876, 6939, 3640, 3641,
-5297, 718, 662, 1291, 1278, 5238, 7727, 7560, 7001, 7728, 3260,
-5298, 450, 343, 385, 1011, 4440, 4357, 4462, 7101, 7102, 7541,
-5299, 1089, 494, 649, 1088, 7229, 5014, 6136, 2713, 7334, 6137,
-5300, 649, 494, 562, 1088, 5014, 4713, 5011, 6137, 7334, 6130,
-5301, 958, 1088, 374, 494, 2709, 7267, 6000, 6002, 7334, 4509,
-5302, 374, 1088, 562, 494, 7267, 6130, 4711, 4509, 7334, 4713,
-5303, 294, 93, 848, 125, 3876, 7465, 7370, 6939, 3641, 1924,
-5304, 713, 1333, 766, 740, 7048, 7049, 5420, 5359, 8000, 5419,
-5305, 1364, 774, 737, 772, 6485, 5448, 6480, 6482, 5451, 5439,
-5306, 657, 1303, 715, 675, 7940, 5867, 5226, 5103, 7962, 5228,
-5307, 1326, 1325, 759, 1291, 3270, 7142, 5981, 2689, 3495, 6444,
-5308, 1219, 522, 594, 523, 6239, 4831, 6347, 7702, 4597, 4832,
-5309, 238, 817, 237, 35, 6189, 5824, 3709, 3707, 5825, 3706,
-5310, 418, 417, 991, 1110, 4252, 7621, 5918, 5919, 5935, 2774,
-5311, 900, 36, 181, 35, 5569, 7568, 2072, 6188, 1559, 8001,
-5312, 293, 92, 929, 124, 3873, 6938, 7374, 7789, 3639, 2135,
-5313, 1299, 1333, 1277, 740, 3141, 2698, 3397, 7409, 8000, 7408,
-5314, 507, 1107, 397, 508, 6016, 6511, 4544, 4548, 6017, 4546,
-5315, 1075, 563, 942, 366, 5931, 7973, 2663, 7963, 4715, 5887,
-5316, 582, 1226, 1121, 1225, 6809, 3063, 6215, 6194, 3256, 3200,
-5317, 460, 530, 457, 1124, 4619, 4618, 4384, 5634, 6729, 8002,
-5318, 1227, 1127, 1198, 566, 3212, 3211, 3215, 6708, 7630, 6703,
-5319, 825, 908, 196, 51, 2163, 2089, 1875, 7804, 8003, 7803,
-5320, 50, 351, 194, 49, 4014, 7632, 7330, 1573, 4015, 7325,
-5321, 713, 1333, 1277, 1345, 7048, 2698, 7017, 7018, 1713, 2697,
-5322, 1115, 475, 1053, 454, 7616, 5637, 2796, 6756, 4463, 6061,
-5323, 1075, 575, 603, 563, 5892, 5004, 5929, 5931, 4761, 4865,
-5324, 463, 1031, 353, 316, 5796, 5500, 4392, 4393, 8004, 4063,
-5325, 943, 575, 1075, 366, 5891, 5892, 2664, 5888, 4760, 7963,
-5326, 490, 357, 320, 1039, 4486, 4067, 4484, 7564, 7549, 7911,
-5327, 478, 939, 940, 784, 7801, 2233, 5773, 5699, 2229, 2231,
-5328, 472, 491, 1148, 1047, 4492, 6728, 7431, 7432, 7976, 2894,
-5329, 1230, 564, 1134, 552, 6966, 7637, 3223, 6967, 4720, 6536,
-5330, 573, 575, 616, 1076, 4762, 5142, 4908, 7998, 5890, 7077,
-5331, 563, 603, 1205, 497, 4865, 7441, 7805, 4782, 4863, 7766,
-5332, 532, 428, 1001, 531, 4622, 7818, 6293, 4624, 4621, 6228,
-5333, 569, 1117, 1154, 1161, 6236, 2913, 5789, 6238, 3060, 2938,
-5334, 8, 146, 224, 784, 3548, 7823, 3676, 5877, 1758, 5700,
-5335, 568, 377, 493, 964, 4734, 4506, 4735, 7861, 7032, 7030,
-5336, 202, 880, 58, 203, 2009, 5596, 6170, 1439, 2010, 6171,
-5337, 1010, 1071, 449, 854, 2637, 5809, 5808, 2433, 2634, 6618,
-5338, 417, 523, 1110, 524, 4596, 6599, 5935, 4598, 4600, 5936,
-5339, 147, 146, 8, 784, 1382, 3548, 3547, 1759, 1758, 5877,
-5340, 1186, 640, 1220, 1168, 6518, 6370, 3169, 3028, 6520, 3168,
-5341, 1306, 685, 1317, 1272, 6204, 6700, 3362, 3506, 7249, 3368,
-5342, 17, 335, 229, 796, 3975, 4076, 3687, 7985, 7606, 7918,
-5343, 796, 17, 159, 229, 7985, 3569, 1795, 7918, 3687, 6593,
-5344, 1272, 685, 1317, 698, 7249, 6700, 3368, 5777, 5176, 6583,
-5345, 149, 225, 787, 786, 5575, 7081, 1767, 1765, 7090, 1769,
-5346, 17, 157, 16, 335, 3568, 3565, 1509, 3975, 6059, 3976,
-5347, 213, 212, 67, 890, 1449, 6801, 7995, 2040, 2039, 7243,
-5348, 942, 563, 1075, 1074, 7973, 5931, 2663, 2661, 5646, 2665,
-5349, 375, 804, 232, 959, 5522, 5614, 4130, 5523, 2289, 7961,
-5350, 1156, 978, 1056, 393, 2921, 2578, 2922, 7718, 7719, 7720,
-5351, 743, 1238, 1300, 755, 7896, 3478, 6815, 5377, 6944, 6813,
-5352, 1312, 702, 694, 683, 6004, 5190, 7947, 7753, 5189, 5184,
-5353, 628, 1194, 1244, 1248, 6143, 3292, 6141, 7760, 3310, 3312,
-5354, 724, 1322, 1319, 1311, 7626, 1714, 7388, 5686, 3209, 3210,
-5355, 1117, 453, 1118, 574, 7800, 7970, 2805, 6237, 4757, 7393,
-5356, 604, 1301, 657, 1268, 7903, 7930, 5055, 7871, 3481, 7941,
-5357, 426, 365, 999, 456, 4277, 5898, 7290, 4714, 4369, 7193,
-5358, 878, 201, 56, 200, 2004, 6331, 7839, 2003, 1437, 7842,
-5359, 1024, 457, 1023, 349, 6275, 5697, 2478, 5508, 4371, 5507,
-5360, 1206, 1117, 1118, 574, 3102, 2805, 3103, 5956, 6237, 7393,
-5361, 976, 388, 1100, 974, 7519, 7516, 2749, 2339, 5678, 2748,
-5362, 1275, 1274, 1208, 610, 3263, 3398, 3399, 5617, 5763, 5619,
-5363, 803, 482, 232, 959, 6164, 4448, 5651, 2288, 6165, 7961,
-5364, 753, 751, 1342, 1366, 5367, 7302, 6828, 6415, 6416, 1662,
-5365, 1078, 570, 1079, 1209, 5584, 8005, 2677, 3115, 7434, 3116,
-5366, 181, 180, 900, 35, 1417, 2073, 2072, 8001, 6180, 6188,
-5367, 1340, 1294, 745, 1270, 3261, 7640, 5970, 3208, 3535, 6811,
-5368, 779, 1366, 771, 753, 6539, 6414, 5490, 5484, 6415, 5441,
-5369, 779, 1371, 738, 1367, 6525, 6526, 5477, 6538, 1632, 7902,
-5370, 1230, 555, 1132, 564, 7324, 5973, 3074, 6966, 4719, 5974,
-5371, 1032, 876, 353, 1031, 2500, 5502, 7214, 2502, 2498, 5500,
-5372, 1139, 1038, 1140, 467, 2867, 2869, 2871, 7906, 7547, 7545,
-5373, 550, 466, 1139, 467, 4680, 7544, 7421, 4679, 4477, 7906,
-5374, 934, 302, 853, 135, 7216, 7992, 2215, 2144, 7160, 1934,
-5375, 857, 179, 180, 35, 1941, 1416, 1942, 6052, 5822, 6180,
-5376, 250, 47, 823, 249, 3743, 7040, 7042, 3745, 3741, 6751,
-5377, 1158, 1100, 387, 495, 2943, 7688, 7591, 6573, 7852, 4763,
-5378, 495, 499, 1100, 387, 4764, 7958, 7852, 4763, 4519, 7688,
-5379, 59, 829, 203, 204, 7887, 1884, 8006, 7251, 1883, 1440,
-5380, 499, 388, 1100, 387, 4520, 7516, 7958, 4519, 4162, 7688,
-5381, 976, 387, 240, 997, 6079, 4157, 6078, 2398, 7593, 6836,
-5382, 399, 981, 982, 1102, 5759, 2589, 5760, 6997, 2753, 2752,
-5383, 271, 916, 270, 68, 7218, 6196, 3808, 3806, 6197, 3804,
-5384, 595, 526, 527, 1190, 4836, 4610, 4837, 6053, 5720, 6306,
-5385, 892, 69, 361, 324, 8007, 4035, 7011, 7015, 3948, 4071,
-5386, 474, 1052, 1153, 475, 6417, 2909, 7763, 4502, 5941, 7615,
-5387, 1021, 348, 1022, 455, 7092, 7905, 2472, 6663, 4365, 5747,
-5388, 670, 654, 1315, 608, 5089, 7233, 6055, 5088, 5038, 6057,
-5389, 771, 779, 738, 1367, 5490, 5477, 5437, 6537, 6538, 7902,
-5390, 836, 72, 217, 918, 6669, 5537, 1898, 2205, 5536, 2108,
-5391, 804, 803, 232, 959, 1820, 5651, 5614, 2289, 2288, 7961,
-5392, 1204, 585, 1263, 554, 8008, 6358, 3361, 7734, 4805, 7971,
-5393, 738, 1367, 1353, 1348, 7902, 1639, 6615, 6616, 1640, 1660,
-5394, 18, 336, 19, 160, 3978, 3977, 1511, 3570, 7064, 3573,
-5395, 472, 554, 473, 1150, 4689, 4688, 4488, 7581, 7430, 7111,
-5396, 704, 685, 703, 1335, 5195, 5191, 5196, 6205, 6206, 6664,
-5397, 1353, 1367, 738, 1371, 1639, 7902, 6615, 1610, 1632, 6526,
-5398, 814, 970, 969, 425, 2321, 2323, 2319, 5612, 6818, 7050,
-5399, 966, 810, 811, 235, 2309, 1841, 2310, 6037, 7054, 6039,
-5400, 473, 1050, 362, 1049, 7266, 6692, 4419, 6608, 2556, 7551,
-5401, 966, 235, 967, 378, 6037, 6038, 2314, 7023, 4135, 7022,
-5402, 1220, 641, 1164, 640, 6369, 6261, 3167, 6370, 4981, 7981,
-5403, 1133, 1230, 1132, 564, 3075, 3074, 2850, 6965, 6966, 5974,
-5404, 810, 378, 341, 235, 7109, 4136, 7122, 7054, 4135, 4082,
-5405, 965, 810, 966, 378, 2307, 2309, 2311, 6294, 7109, 7023,
-5406, 399, 1102, 398, 981, 6997, 6990, 4195, 5759, 2753, 7922,
-5407, 1254, 588, 1253, 1239, 7690, 7125, 3333, 3331, 8009, 3328,
-5408, 985, 1057, 260, 406, 2582, 7993, 6102, 6110, 6395, 4215,
-5409, 364, 898, 1013, 328, 5842, 2445, 6060, 4098, 5845, 5849,
-5410, 718, 1278, 1291, 1279, 7001, 3260, 7560, 7004, 3443, 3454,
-5411, 367, 1115, 1073, 939, 6753, 2795, 7646, 6752, 2794, 2656,
-5412, 1242, 1238, 683, 624, 3286, 6863, 7859, 7480, 6848, 5129,
-5413, 651, 662, 716, 1278, 5070, 5236, 5233, 7740, 7728, 7002,
-5414, 265, 831, 63, 266, 7575, 8010, 3789, 3793, 8011, 3791,
-5415, 690, 699, 1299, 740, 5181, 7661, 7680, 5186, 5185, 7409,
-5416, 594, 696, 593, 1258, 5149, 5148, 4833, 6346, 6341, 7521,
-5417, 914, 267, 209, 64, 5548, 6671, 2100, 5581, 3794, 7670,
-5418, 742, 1356, 1319, 1322, 6957, 1710, 6466, 8012, 1688, 1714,
-5419, 1332, 1341, 682, 733, 1732, 6787, 5869, 7184, 7548, 5303,
-5420, 1042, 886, 887, 322, 2530, 2032, 2531, 7879, 6190, 6191,
-5421, 986, 829, 260, 261, 2366, 6760, 6807, 6949, 8013, 3778,
-5422, 373, 799, 230, 954, 7671, 6996, 4126, 5620, 2274, 5604,
-5423, 815, 970, 425, 971, 2322, 6818, 6978, 2324, 2327, 6819,
-5424, 815, 970, 814, 425, 2322, 2321, 1853, 6978, 6818, 5612,
-5425, 1144, 486, 1145, 576, 7354, 6432, 2886, 5599, 4769, 5598,
-5426, 958, 959, 1089, 494, 2290, 2712, 2711, 6002, 5531, 7229,
-5427, 1077, 570, 573, 368, 7188, 4756, 7997, 5743, 4742, 4754,
-5428, 1125, 530, 1197, 1124, 8014, 5656, 3066, 2826, 6729, 3065,
-5429, 409, 1060, 986, 912, 5814, 2595, 8015, 8016, 2594, 2368,
-5430, 777, 763, 1329, 1338, 5467, 6611, 7288, 6492, 6612, 1676,
-5431, 912, 1060, 830, 409, 2594, 2596, 2199, 8016, 5814, 5886,
-5432, 1364, 1352, 737, 1349, 1615, 6481, 6480, 1623, 1633, 7470,
-5433, 737, 769, 715, 1352, 5434, 5431, 5318, 6481, 6472, 8017,
-5434, 715, 769, 1321, 1352, 5431, 7908, 7257, 8017, 6472, 1723,
-5435, 715, 1352, 1332, 737, 8017, 1721, 5868, 5318, 6481, 7183,
-5436, 1321, 1352, 1332, 715, 1723, 1721, 1724, 7257, 8017, 5868,
-5437, 494, 482, 958, 959, 4508, 6001, 6002, 5531, 6165, 2290,
-5438, 228, 334, 793, 15, 4075, 6385, 6409, 3685, 3973, 6410,
-5439, 767, 1360, 736, 1371, 6367, 5978, 5425, 6527, 1645, 6667,
-5440, 1312, 1242, 694, 1311, 3527, 6104, 7947, 3529, 3519, 5985,
-5441, 334, 948, 369, 476, 6386, 6438, 4117, 4427, 5771, 4428,
-5442, 769, 1348, 1321, 1352, 7672, 1722, 7908, 6472, 1647, 1723,
-5443, 1112, 635, 706, 1171, 5926, 5202, 5754, 2988, 6305, 7959,
-5444, 1189, 644, 1196, 1195, 6548, 6082, 3314, 3058, 7055, 3313,
-5445, 824, 907, 252, 981, 2162, 6761, 7332, 2352, 2351, 6721,
-5446, 1156, 394, 395, 1058, 6174, 4183, 7815, 3010, 7665, 7013,
-5447, 1156, 504, 1222, 1239, 6173, 6587, 3190, 3302, 6314, 3303,
-5448, 980, 508, 1107, 1102, 6510, 6017, 2766, 2754, 6991, 2927,
-5449, 1095, 596, 568, 584, 7084, 4905, 5639, 5649, 4842, 4877,
-5450, 1095, 596, 1218, 1094, 7084, 6496, 3161, 2734, 5527, 3160,
-5451, 1254, 1239, 1188, 620, 3331, 3322, 3332, 6850, 8018, 7587,
-5452, 539, 1000, 538, 437, 7087, 7373, 4647, 4645, 6837, 4644,
-5453, 1188, 1239, 1222, 620, 3322, 3303, 3288, 7587, 8018, 7706,
-5454, 1254, 1269, 672, 587, 3390, 7585, 6849, 6035, 6036, 5093,
-5455, 243, 390, 975, 244, 4166, 6085, 6528, 3727, 4167, 6212,
-5456, 945, 226, 789, 333, 8019, 7082, 2246, 7967, 4046, 7797,
-5457, 672, 710, 679, 1256, 5311, 5356, 5252, 7612, 7277, 6853,
-5458, 1222, 1239, 504, 620, 3303, 6314, 6587, 7706, 8018, 4919,
-5459, 330, 367, 224, 783, 4114, 4113, 3992, 5971, 6882, 6988,
-5460, 955, 800, 956, 481, 2277, 2279, 2281, 5624, 5873, 5623,
-5461, 481, 800, 231, 337, 5873, 5871, 4446, 4447, 5966, 4078,
-5462, 655, 632, 633, 1191, 5047, 4957, 5111, 7865, 6184, 6798,
-5463, 399, 398, 252, 981, 4195, 4191, 4193, 5759, 7922, 6721,
-5464, 150, 149, 10, 787, 1385, 3553, 3552, 1768, 1767, 7080,
-5465, 980, 981, 251, 398, 2353, 8020, 7058, 7826, 7922, 4190,
-5466, 397, 1107, 507, 979, 6511, 6016, 4544, 6544, 2767, 7620,
-5467, 39, 38, 184, 819, 1562, 5924, 7514, 7146, 5925, 1863,
-5468, 187, 42, 188, 865, 7209, 5779, 1424, 1964, 5781, 1965,
-5469, 253, 981, 825, 982, 5758, 2354, 6719, 5761, 2589, 2356,
-5470, 985, 1106, 405, 984, 2763, 6644, 6109, 2364, 2764, 6118,
-5471, 1244, 1260, 629, 674, 3347, 5590, 7654, 7679, 5563, 5146,
-5472, 1227, 530, 1197, 1125, 5609, 5656, 3069, 3067, 8014, 3066,
-5473, 308, 1015, 344, 860, 6558, 5836, 3997, 5803, 2450, 6468,
-5474, 451, 582, 384, 1120, 4767, 4766, 4353, 5942, 5943, 7584,
-5475, 243, 975, 977, 820, 6528, 2344, 6861, 6154, 2335, 2341,
-5476, 617, 1257, 646, 656, 6629, 6630, 5024, 5051, 6175, 5052,
-5477, 647, 579, 1199, 555, 5000, 6747, 6559, 4999, 4786, 7323,
-5478, 582, 1121, 384, 1120, 6215, 5949, 4766, 5943, 2814, 7584,
-5479, 980, 981, 824, 251, 2353, 2352, 2349, 7058, 8020, 7008,
-5480, 193, 906, 47, 192, 2084, 7041, 7260, 1429, 2085, 7259,
-5481, 194, 48, 824, 49, 6584, 7009, 1873, 7325, 1572, 7010,
-5482, 193, 906, 824, 48, 2084, 2193, 1874, 6585, 7953, 7009,
-5483, 251, 981, 252, 398, 8020, 6721, 3751, 4190, 7922, 4191,
-5484, 75, 277, 837, 278, 3825, 7221, 7121, 3827, 3829, 7872,
-5485, 824, 981, 252, 251, 2352, 6721, 7332, 7008, 8020, 3751,
-5486, 375, 376, 339, 960, 4450, 4132, 4129, 5524, 5601, 5494,
-5487, 1229, 553, 1301, 600, 7933, 7932, 3496, 7868, 4852, 7869,
-5488, 1243, 521, 593, 522, 6638, 4829, 6637, 6155, 4594, 4830,
-5489, 265, 988, 989, 412, 6897, 2375, 5578, 4232, 6893, 5580,
-5490, 1109, 1182, 1055, 520, 3018, 3017, 2772, 6362, 6363, 7725,
-5491, 693, 1238, 692, 623, 6862, 8021, 5262, 5166, 6847, 5163,
-5492, 210, 267, 65, 64, 6672, 3795, 6795, 7669, 3794, 1588,
-5493, 910, 257, 404, 258, 5975, 4208, 5498, 6373, 3769, 4209,
-5494, 1101, 1160, 518, 1194, 2959, 5828, 5826, 3055, 3054, 6135,
-5495, 413, 266, 914, 989, 4235, 5582, 5546, 7402, 5579, 2373,
-5496, 1109, 413, 989, 412, 7724, 7402, 2770, 6522, 4237, 5580,
-5497, 418, 992, 991, 834, 5920, 2602, 5918, 7866, 2383, 2380,
-5498, 1244, 674, 629, 592, 7679, 5146, 7654, 7655, 5098, 4942,
-5499, 603, 585, 616, 1207, 4901, 5032, 5031, 6220, 5906, 5554,
-5500, 1144, 486, 1143, 1042, 7354, 7960, 2883, 2881, 7936, 2879,
-5501, 605, 602, 1307, 677, 4872, 7447, 6770, 5108, 5107, 7253,
-5502, 26, 233, 807, 806, 3694, 8022, 6139, 6132, 7813, 1829,
-5503, 276, 277, 423, 994, 3826, 4266, 4265, 7912, 7154, 6689,
-5504, 778, 1366, 1363, 751, 7794, 1606, 7426, 5470, 6416, 7744,
-5505, 342, 236, 813, 379, 4083, 7850, 5916, 4138, 4137, 5917,
-5506, 342, 968, 485, 379, 5915, 5811, 4457, 4138, 5812, 4497,
-5507, 1162, 422, 527, 1159, 6066, 4609, 6307, 2971, 6688, 6923,
-5508, 221, 278, 76, 75, 6860, 3828, 6859, 7729, 3827, 1599,
-5509, 1178, 653, 649, 1213, 6360, 5035, 5907, 3139, 5831, 6138,
-5510, 419, 992, 272, 917, 7617, 8023, 4253, 7977, 2382, 6985,
-5511, 54, 877, 55, 200, 7712, 7988, 1578, 6769, 2001, 7841,
-5512, 419, 992, 418, 272, 7617, 5920, 4255, 4253, 8023, 4251,
-5513, 1066, 433, 1002, 434, 5815, 5816, 2619, 7341, 4301, 8024,
-5514, 166, 232, 23, 24, 5650, 3693, 3581, 3584, 3692, 1516,
-5515, 276, 919, 837, 994, 6026, 2206, 7847, 7912, 2389, 2388,
-5516, 72, 71, 216, 918, 1595, 5674, 5535, 5536, 7338, 2109,
-5517, 1065, 536, 537, 434, 7476, 4640, 6420, 6422, 4637, 4638,
-5518, 55, 877, 54, 317, 7988, 7712, 1578, 3934, 7493, 3935,
-5519, 1156, 1180, 506, 505, 3016, 6767, 6765, 6172, 6093, 4542,
-5520, 1002, 433, 432, 536, 5816, 4298, 5837, 5838, 4635, 4634,
-5521, 925, 1064, 844, 432, 2612, 2611, 2208, 5876, 5839, 7473,
-5522, 979, 1180, 506, 1058, 3009, 6767, 6919, 2588, 3012, 6766,
-5523, 87, 288, 86, 118, 3858, 3857, 1536, 3628, 7876, 3627,
-5524, 45, 312, 868, 867, 3924, 7590, 6772, 6398, 6399, 1975,
-5525, 485, 1096, 968, 967, 6202, 2738, 5811, 7337, 2737, 2317,
-5526, 748, 747, 1255, 761, 5345, 5937, 7378, 5400, 5424, 6296,
-5527, 536, 434, 1002, 433, 4637, 8024, 5838, 4635, 4301, 5816,
-5528, 121, 291, 89, 290, 7027, 3866, 3633, 6858, 3868, 3864,
-5529, 89, 120, 121, 290, 3632, 1474, 3633, 3864, 6833, 6858,
-5530, 567, 530, 1227, 1125, 4765, 5609, 5608, 7649, 8014, 3067,
-5531, 925, 844, 288, 432, 2208, 7563, 7561, 5876, 7473, 4294,
-5532, 457, 530, 370, 1125, 4618, 4676, 4373, 6276, 8014, 6738,
-5533, 1248, 673, 591, 1224, 8025, 5096, 6975, 3311, 6316, 6976,
-5534, 1330, 1357, 756, 1345, 1679, 6283, 7938, 1682, 1683, 7934,
-5535, 444, 851, 1067, 443, 5767, 2623, 7777, 4331, 6895, 8026,
-5536, 1242, 624, 683, 590, 7480, 5129, 7859, 7481, 5058, 5130,
-5537, 1067, 443, 1007, 544, 8026, 7174, 2622, 7778, 4661, 7867,
-5538, 54, 877, 353, 317, 7712, 7492, 4018, 3935, 7493, 4087,
-5539, 738, 1355, 1353, 1371, 6666, 1609, 6615, 6526, 1608, 1610,
-5540, 360, 324, 1046, 491, 4094, 6640, 6643, 4489, 4491, 7756,
-5541, 945, 226, 944, 789, 8019, 6221, 2248, 2246, 7082, 2244,
-5542, 99, 300, 933, 301, 3894, 7479, 6887, 3896, 3898, 7851,
-5543, 1067, 851, 932, 443, 2623, 2213, 2621, 8026, 6895, 5741,
-5544, 1067, 443, 932, 1007, 8026, 5741, 2621, 2622, 7174, 2426,
-5545, 272, 992, 834, 917, 8023, 2383, 6209, 6985, 2382, 2172,
-5546, 1264, 608, 1197, 1292, 6011, 6012, 3363, 3517, 6058, 3455,
-5547, 1351, 773, 1318, 1327, 6440, 7897, 1727, 1729, 6439, 1730,
-5548, 418, 992, 834, 272, 5920, 2383, 7866, 4251, 8023, 6209,
-5549, 1318, 773, 1351, 776, 7897, 6440, 1727, 7663, 5460, 7312,
-5550, 684, 1307, 605, 1267, 7732, 6770, 5131, 7733, 1735, 7091,
-5551, 886, 358, 321, 63, 6187, 4068, 7350, 6185, 4029, 3942,
-5552, 765, 773, 1318, 776, 5455, 7897, 7588, 5461, 5460, 7663,
-5553, 955, 800, 481, 337, 2277, 5873, 5624, 5965, 5966, 4447,
-5554, 485, 235, 967, 812, 4458, 6038, 7337, 7986, 7300, 2313,
-5555, 175, 812, 174, 30, 1843, 1842, 1410, 3597, 7536, 3598,
-5556, 848, 295, 439, 1003, 7464, 4315, 7369, 2414, 7914, 6941,
-5557, 561, 618, 650, 1290, 5010, 5017, 5016, 6827, 7929, 7684,
-5558, 1040, 885, 1041, 321, 2525, 2527, 2529, 7412, 7289, 7351,
-5559, 1177, 651, 716, 1278, 7440, 5233, 7909, 3410, 7740, 7002,
-5560, 9, 148, 331, 786, 3551, 7394, 3966, 7100, 1764, 7089,
-5561, 77, 899, 221, 76, 6062, 2066, 7186, 1600, 5847, 6859,
-5562, 727, 1344, 712, 1314, 7837, 7942, 5277, 7806, 2727, 7894,
-5563, 480, 336, 372, 953, 4445, 4123, 4464, 5607, 6998, 7117,
-5564, 814, 236, 32, 329, 5613, 3700, 7107, 5611, 4043, 3961,
-5565, 987, 410, 518, 411, 5921, 4579, 5827, 7969, 4231, 4580,
-5566, 563, 497, 1205, 1073, 4782, 7766, 7805, 5644, 7645, 3098,
-5567, 484, 378, 965, 568, 4456, 6294, 7005, 4736, 4878, 5638,
-5568, 225, 332, 787, 366, 4045, 7984, 7081, 4112, 4111, 5889,
-5569, 782, 938, 1013, 454, 2226, 2572, 2444, 5856, 6757, 5851,
-5570, 10, 332, 150, 787, 3969, 8027, 3552, 7080, 7984, 1768,
-5571, 243, 902, 242, 40, 7689, 7034, 3724, 3722, 7035, 3720,
-5572, 975, 390, 391, 244, 6085, 4171, 7957, 6212, 4167, 4169,
-5573, 403, 983, 909, 827, 6478, 2359, 6647, 6557, 2358, 2196,
-5574, 501, 389, 1163, 500, 4524, 6022, 6032, 4526, 4522, 6023,
-5575, 978, 905, 822, 247, 2345, 2160, 2346, 7461, 6656, 6659,
-5576, 1019, 864, 1020, 347, 2462, 2464, 2466, 7552, 5793, 6087,
-5577, 1122, 498, 582, 455, 7601, 4855, 7838, 6662, 4517, 4854,
-5578, 1338, 763, 1294, 765, 6612, 7835, 3213, 7589, 5416, 6321,
-5579, 710, 1289, 745, 1270, 7279, 7924, 5376, 6812, 3207, 6811,
-5580, 55, 877, 317, 878, 7988, 7493, 3934, 7840, 2005, 7526,
-5581, 672, 1269, 1254, 1256, 7585, 3390, 6849, 7612, 3444, 3447,
-5582, 700, 1289, 745, 710, 7278, 7924, 5337, 5312, 7279, 5376,
-5583, 1354, 1360, 767, 1369, 1650, 6367, 6365, 1651, 1646, 7652,
-5584, 712, 711, 670, 1304, 5219, 5216, 5217, 7129, 6925, 7128,
-5585, 1252, 709, 748, 734, 6248, 5368, 6784, 6246, 5306, 5369,
-5586, 822, 246, 44, 189, 7458, 3732, 7513, 1870, 7659, 7875,
-5587, 519, 1185, 1194, 1160, 7427, 3056, 6133, 6134, 3026, 3054,
-5588, 1250, 643, 679, 663, 7372, 5115, 6854, 6855, 5074, 5122,
-5589, 766, 1357, 1361, 1333, 7046, 1652, 7833, 7049, 1693, 1694,
-5590, 1035, 1136, 1034, 465, 2858, 2857, 2511, 7452, 7542, 7708,
-5591, 859, 1014, 308, 1015, 2448, 7566, 5801, 2449, 2451, 6558,
-5592, 255, 198, 256, 909, 6452, 7716, 3763, 6983, 2091, 6648,
-5593, 403, 256, 909, 402, 4205, 6648, 6647, 4207, 4203, 7230,
-5594, 1109, 411, 988, 1160, 6523, 6892, 2771, 2936, 7739, 2934,
-5595, 859, 1014, 858, 345, 2448, 2447, 1948, 8028, 7194, 6575,
-5596, 1319, 702, 760, 742, 6005, 5395, 6464, 6466, 5328, 5396,
-5597, 859, 345, 858, 36, 8028, 6575, 1948, 7567, 4001, 7550,
-5598, 325, 70, 361, 893, 3951, 4034, 4095, 7595, 7039, 7038,
-5599, 744, 1356, 742, 1322, 7614, 6957, 5336, 7825, 1688, 8012,
-5600, 213, 890, 67, 68, 2040, 7243, 7995, 6270, 7428, 1591,
-5601, 360, 68, 891, 324, 4032, 7919, 6642, 4094, 3949, 6641,
-5602, 1330, 1323, 735, 1295, 1699, 5927, 7982, 1685, 1698, 7454,
-5603, 456, 1014, 308, 345, 6116, 7566, 4367, 4368, 7194, 4103,
-5604, 37, 859, 181, 36, 5802, 1946, 7106, 1560, 7567, 7568,
-5605, 1033, 878, 317, 877, 2504, 7526, 7327, 2503, 2005, 7493,
-5606, 37, 36, 181, 818, 1560, 7568, 7106, 8029, 7363, 1862,
-5607, 308, 1014, 859, 345, 7566, 2448, 5801, 4103, 7194, 8028,
-5608, 1098, 533, 996, 532, 6903, 5717, 2744, 5982, 4627, 5718,
-5609, 870, 1025, 350, 1026, 2480, 7531, 6780, 2482, 2484, 7202,
-5610, 856, 237, 142, 106, 6580, 7857, 1939, 7817, 3703, 3671,
-5611, 870, 1025, 869, 313, 2480, 2479, 1981, 6782, 7636, 7634,
-5612, 1000, 1054, 538, 436, 2570, 6311, 7373, 7177, 7347, 4642,
-5613, 459, 1025, 350, 313, 7530, 7531, 4378, 4379, 7636, 4060,
-5614, 1098, 533, 613, 534, 6903, 4950, 6501, 6502, 4630, 4951,
-5615, 284, 112, 82, 113, 7293, 3617, 3845, 7774, 1466, 3618,
-5616, 350, 1025, 870, 313, 7531, 2480, 6780, 4060, 7636, 6782,
-5617, 108, 79, 78, 280, 3610, 1528, 3609, 6635, 3835, 3834,
-5618, 1098, 533, 998, 996, 6903, 7484, 2743, 2744, 5717, 2401,
-5619, 998, 533, 429, 996, 7484, 4625, 5715, 2401, 5717, 5716,
-5620, 1353, 738, 750, 725, 6615, 5355, 6613, 7633, 5322, 5352,
-5621, 435, 290, 291, 927, 4302, 3868, 4303, 6456, 6455, 7029,
-5622, 319, 1037, 881, 1036, 7234, 2515, 5595, 7353, 2517, 2513,
-5623, 1067, 1007, 1164, 544, 2622, 2949, 2953, 7778, 7867, 6259,
-5624, 466, 1036, 319, 355, 7352, 7353, 4400, 4401, 5504, 4089,
-5625, 921, 281, 109, 79, 5695, 7389, 2117, 7749, 3836, 3611,
-5626, 1007, 442, 543, 443, 7062, 4658, 7063, 7174, 4328, 4660,
-5627, 303, 935, 137, 304, 7697, 2146, 7695, 3907, 6125, 7972,
-5628, 856, 343, 105, 937, 8030, 3995, 7925, 2218, 7828, 7926,
-5629, 675, 750, 725, 1324, 5353, 5352, 5269, 5989, 7904, 6634,
-5630, 105, 343, 306, 937, 3995, 4356, 3912, 7926, 7828, 6429,
-5631, 850, 130, 96, 298, 1927, 3649, 5832, 5833, 7343, 3887,
-5632, 341, 810, 484, 378, 7122, 7108, 4453, 4136, 7109, 4456,
-5633, 151, 226, 12, 789, 7996, 3680, 3557, 1773, 7082, 7796,
-5634, 162, 337, 800, 799, 6778, 5966, 1806, 1804, 5967, 1808,
-5635, 601, 1249, 1184, 609, 7360, 3337, 5680, 4888, 6884, 6661,
-5636, 1263, 1204, 1175, 585, 3361, 3308, 3376, 6358, 8008, 7225,
-5637, 164, 801, 231, 802, 1810, 5870, 7195, 1812, 1814, 7336,
-5638, 950, 949, 496, 1082, 2263, 6383, 6891, 2685, 2684, 6338,
-5639, 792, 948, 947, 369, 2255, 2257, 2253, 6791, 6438, 6792,
-5640, 880, 1036, 319, 881, 2512, 7353, 5594, 2014, 2513, 5595,
-5641, 793, 334, 228, 476, 6385, 4075, 6409, 6387, 4427, 4426,
-5642, 988, 411, 987, 1160, 6892, 7969, 2597, 2934, 7739, 2935,
-5643, 468, 357, 490, 1040, 4406, 4486, 4487, 7411, 7395, 7565,
-5644, 643, 663, 1249, 609, 5074, 6856, 7361, 5072, 5073, 6884,
-5645, 670, 1292, 665, 586, 6056, 7790, 5121, 5090, 6686, 5078,
-5646, 1127, 1025, 459, 1126, 2830, 7530, 7320, 2832, 2828, 7319,
-5647, 191, 905, 823, 46, 2082, 2192, 1872, 7990, 6462, 6461,
-5648, 681, 1191, 1173, 1247, 7864, 3047, 6262, 6241, 3305, 3304,
-5649, 1249, 643, 1250, 663, 7361, 7372, 3348, 6856, 5074, 6855,
-5650, 1046, 1047, 491, 324, 2547, 7976, 7756, 6640, 7007, 4491,
-5651, 543, 640, 1164, 641, 4977, 7981, 6260, 4979, 4981, 6261,
-5652, 462, 1131, 1132, 1030, 5782, 2847, 7496, 5783, 2843, 2845,
-5653, 459, 1025, 1127, 1026, 7530, 2830, 7320, 7532, 2484, 2831,
-5654, 908, 826, 255, 254, 2195, 6982, 7730, 6878, 6877, 3760,
-5655, 196, 908, 52, 51, 2089, 7274, 7273, 7803, 8003, 1575,
-5656, 1040, 357, 490, 1039, 7395, 4486, 7565, 2526, 7549, 7564,
-5657, 1024, 370, 349, 313, 6739, 4120, 5508, 7635, 4119, 4100,
-5658, 913, 831, 265, 988, 2200, 7575, 6713, 2372, 2371, 6897,
-5659, 472, 1048, 361, 1047, 6675, 6868, 4416, 7432, 2550, 7012,
-5660, 1164, 543, 1068, 1168, 6260, 6514, 2950, 2964, 6515, 2962,
-5661, 639, 1186, 1099, 1168, 6517, 3029, 6041, 6519, 3028, 2989,
-5662, 1057, 986, 407, 1105, 2583, 6947, 7413, 2761, 2760, 7423,
-5663, 886, 63, 321, 885, 6185, 3942, 7350, 2029, 7291, 7289,
-5664, 635, 1171, 636, 706, 6305, 6762, 4966, 5202, 7959, 5203,
-5665, 1195, 644, 646, 655, 7055, 5022, 7533, 7870, 5049, 5050,
-5666, 361, 324, 472, 1047, 4071, 4417, 4416, 7012, 7007, 7432,
-5667, 77, 838, 222, 816, 7118, 1901, 6162, 6120, 1903, 1856,
-5668, 1173, 1191, 681, 633, 3047, 7864, 6262, 8031, 6798, 5124,
-5669, 976, 997, 1100, 387, 2398, 2786, 2749, 6079, 7593, 7688,
-5670, 276, 919, 275, 73, 6026, 7261, 3823, 3821, 6028, 3819,
-5671, 210, 267, 832, 915, 6672, 5549, 1889, 2103, 6797, 2170,
-5672, 480, 953, 372, 1084, 5607, 7117, 4464, 7792, 2694, 7417,
-5673, 491, 1047, 472, 324, 7976, 7432, 4492, 4491, 7007, 4417,
-5674, 1100, 499, 495, 1183, 7958, 4764, 7852, 3053, 5683, 7520,
-5675, 1100, 1183, 1184, 499, 3053, 3100, 3024, 7958, 5683, 5682,
-5676, 1164, 640, 543, 1168, 7981, 4977, 6260, 2964, 6520, 6515,
-5677, 1294, 763, 745, 765, 7835, 5408, 7640, 6321, 5416, 5415,
-5678, 1340, 763, 745, 1294, 5969, 5408, 5970, 3261, 7835, 7640,
-5679, 41, 40, 186, 820, 1564, 5901, 5751, 5753, 5902, 1865,
-5680, 370, 530, 567, 1125, 4676, 4765, 4732, 6738, 8014, 7649,
-5681, 1338, 765, 1318, 776, 7589, 7588, 1726, 7095, 5461, 7663,
-5682, 1265, 1327, 727, 1314, 3448, 7836, 6393, 3462, 3126, 7806,
-5683, 395, 1058, 394, 248, 7013, 7665, 4183, 4181, 6755, 4179,
-5684, 1338, 763, 765, 776, 6612, 5416, 7589, 7095, 5479, 5461,
-5685, 727, 773, 1327, 752, 5442, 6439, 7836, 5363, 5443, 7206,
-5686, 777, 763, 1338, 776, 5467, 6612, 6492, 5482, 5479, 7095,
-5687, 1210, 717, 610, 607, 5963, 5232, 7196, 5995, 5231, 4891,
-5688, 409, 912, 986, 262, 8016, 2368, 8015, 4223, 7425, 7771,
-5689, 473, 1049, 472, 1150, 6608, 6609, 4488, 7111, 2900, 7581,
-5690, 703, 698, 1331, 1317, 5192, 6582, 6942, 6699, 6583, 3282,
-5691, 771, 1348, 738, 750, 7673, 6616, 5437, 5435, 6614, 5355,
-5692, 614, 1268, 657, 1302, 6470, 7941, 5057, 6774, 3485, 7752,
-5693, 1035, 487, 1137, 1136, 5505, 7299, 2860, 2858, 7578, 2862,
-5694, 628, 674, 1244, 592, 5097, 7679, 6141, 5043, 5098, 7655,
-5695, 268, 267, 65, 915, 3799, 3795, 3797, 6832, 6797, 6796,
-5696, 891, 69, 892, 324, 7920, 8007, 2047, 6641, 3948, 7015,
-5697, 1244, 1299, 1277, 674, 3474, 3397, 3406, 7679, 7410, 5561,
-5698, 1231, 487, 604, 553, 7579, 4866, 7808, 7385, 4687, 4867,
-5699, 526, 1162, 1108, 420, 5721, 2948, 5719, 4605, 8032, 6915,
-5700, 394, 1058, 978, 248, 7665, 2587, 7664, 4179, 6755, 7954,
-5701, 355, 487, 1035, 465, 4471, 5505, 5503, 4399, 4472, 7452,
-5702, 395, 248, 249, 1058, 4181, 3742, 4182, 7013, 6755, 8033,
-5703, 296, 930, 440, 295, 7747, 7754, 4318, 3883, 7462, 4317,
-5704, 1315, 654, 712, 1314, 7233, 5218, 7127, 1741, 7807, 7894,
-5705, 249, 248, 823, 1058, 3742, 6460, 6751, 8033, 6755, 2585,
-5706, 823, 1058, 396, 249, 2585, 6918, 7921, 6751, 8033, 4184,
-5707, 1053, 475, 364, 454, 5637, 4424, 5636, 6061, 4463, 4441,
-5708, 396, 1058, 395, 249, 6918, 7013, 4186, 4184, 8033, 4182,
-5709, 1320, 666, 1275, 717, 7176, 6342, 3536, 6906, 5243, 5964,
-5710, 1053, 1115, 1052, 475, 2796, 2974, 2566, 5637, 7616, 5941,
-5711, 275, 1062, 276, 422, 7072, 7931, 3823, 4262, 6065, 4263,
-5712, 1276, 662, 1328, 717, 7791, 7726, 3266, 5962, 5235, 6905,
-5713, 285, 84, 924, 114, 3849, 6956, 6771, 6168, 3621, 2124,
-5714, 397, 508, 980, 398, 4546, 6510, 6509, 4192, 4547, 7826,
-5715, 239, 37, 240, 818, 3711, 3713, 3715, 7342, 8029, 6835,
-5716, 281, 280, 921, 365, 3838, 6636, 5695, 4108, 4107, 5897,
-5717, 845, 926, 1066, 289, 2209, 2618, 2617, 7163, 7863, 7899,
-5718, 46, 47, 823, 192, 1570, 7040, 6461, 7989, 7259, 1871,
-5719, 1000, 1004, 539, 1170, 2419, 7086, 7087, 2976, 2975, 7131,
-5720, 305, 139, 936, 103, 7978, 2148, 7189, 3908, 3665, 7980,
-5721, 534, 431, 1063, 995, 4629, 5912, 7349, 7482, 7486, 2608,
-5722, 287, 843, 925, 431, 6960, 2178, 5874, 4291, 7071, 5875,
-5723, 873, 352, 1029, 315, 7855, 7500, 2491, 7781, 4062, 5996,
-5724, 430, 995, 843, 431, 7485, 2391, 5881, 4292, 7486, 7071,
-5725, 1155, 633, 705, 634, 7742, 5198, 7846, 7478, 4960, 5199,
-5726, 844, 433, 1002, 926, 7474, 5816, 2413, 2179, 5817, 2412,
-5727, 1348, 1370, 771, 1367, 1641, 7674, 7673, 1640, 1612, 6537,
-5728, 254, 982, 253, 908, 6879, 5761, 3757, 6878, 2355, 7937,
-5729, 1008, 445, 1167, 1069, 7173, 5734, 2958, 2645, 5736, 2957,
-5730, 705, 1173, 681, 633, 7845, 6262, 5286, 5198, 8031, 5124,
-5731, 118, 117, 844, 288, 1471, 1916, 1915, 7876, 7562, 7563,
-5732, 1155, 1173, 705, 633, 2991, 7845, 7846, 7742, 8031, 5198,
-5733, 941, 786, 331, 785, 2235, 7089, 7099, 2234, 1766, 5669,
-5734, 1320, 717, 1276, 1328, 6906, 5962, 3265, 1618, 6905, 3266,
-5735, 1067, 545, 1008, 444, 7776, 7583, 2644, 7777, 4664, 5768,
-5736, 12, 13, 790, 333, 1505, 5693, 7795, 3972, 3971, 7686,
-5737, 172, 809, 341, 810, 1834, 6317, 5652, 1836, 1838, 7122,
-5738, 1008, 852, 445, 1069, 2428, 7948, 7173, 2645, 2631, 5736,
-5739, 1119, 578, 1196, 599, 5953, 6080, 3062, 6166, 4876, 7676,
-5740, 606, 1228, 1199, 579, 6678, 3218, 6864, 4875, 6694, 6747,
-5741, 1327, 773, 727, 739, 6439, 5442, 7836, 6442, 5445, 5381,
-5742, 1016, 453, 452, 344, 7824, 4360, 5533, 5835, 4359, 4354,
-5743, 723, 696, 1309, 729, 5281, 6340, 6391, 5313, 5305, 6497,
-5744, 776, 773, 1351, 739, 5460, 6440, 7312, 5459, 5445, 6441,
-5745, 704, 666, 1320, 717, 5197, 7176, 6372, 5339, 5243, 6906,
-5746, 1118, 453, 599, 574, 7970, 4851, 7675, 7393, 4757, 4882,
-5747, 1045, 360, 1046, 471, 7504, 6643, 2544, 5629, 4414, 7758,
-5748, 1044, 359, 1043, 888, 6483, 7624, 2538, 2536, 5820, 2534,
-5749, 1018, 862, 346, 1017, 2458, 7510, 7254, 2460, 2456, 7964,
-5750, 576, 618, 551, 1202, 4913, 4912, 4770, 6486, 8034, 7736,
-5751, 229, 797, 159, 796, 6592, 1797, 6593, 7918, 1799, 1795,
-5752, 1177, 581, 549, 1212, 5510, 4797, 7436, 3134, 5511, 6717,
-5753, 1339, 751, 1363, 1366, 6913, 7744, 1663, 1664, 6416, 1606,
-5754, 445, 301, 933, 300, 4333, 7851, 7172, 4332, 3898, 7479,
-5755, 955, 799, 373, 954, 2276, 7671, 5914, 2278, 2274, 5620,
-5756, 480, 577, 373, 1085, 4773, 4775, 4467, 5622, 7810, 5621,
-5757, 1210, 1176, 1276, 607, 3301, 3402, 3404, 5995, 8035, 5994,
-5758, 179, 817, 180, 35, 1860, 1859, 1416, 5822, 5825, 6180,
-5759, 1328, 662, 730, 717, 7726, 5287, 6564, 6905, 5235, 5288,
-5760, 980, 251, 397, 398, 7058, 4188, 6509, 7826, 4190, 4192,
-5761, 445, 852, 446, 1069, 7948, 7779, 4337, 5736, 2631, 7371,
-5762, 835, 992, 419, 917, 2384, 7617, 7762, 2204, 2382, 7977,
-5763, 1265, 752, 746, 720, 6394, 5362, 5852, 6233, 5361, 5310,
-5764, 781, 223, 77, 5, 6046, 3958, 6045, 5603, 3675, 3673,
-5765, 43, 821, 188, 246, 8036, 1867, 5778, 3731, 7643, 7658,
-5766, 1239, 588, 504, 620, 8009, 4813, 6314, 8018, 4920, 4919,
-5767, 1254, 588, 1239, 620, 7690, 8009, 3331, 6850, 4920, 8018,
-5768, 1156, 504, 394, 393, 6173, 4535, 6174, 7718, 4534, 4180,
-5769, 1308, 1241, 680, 1262, 3509, 6701, 6272, 3508, 3353, 6256,
-5770, 1309, 729, 1330, 1323, 6497, 6498, 1748, 3412, 5928, 1699,
-5771, 318, 880, 1035, 355, 7650, 2510, 7451, 4065, 6325, 5503,
-5772, 471, 1147, 561, 491, 5631, 6114, 4708, 4490, 7751, 4707,
-5773, 701, 1339, 1310, 699, 6911, 3150, 7955, 5244, 6542, 6540,
-5774, 1079, 369, 947, 1080, 7927, 6792, 2676, 2680, 7928, 2678,
-5775, 833, 269, 990, 1061, 6805, 7239, 2379, 2599, 7556, 2600,
-5776, 594, 696, 1259, 630, 5149, 6290, 6401, 4947, 5173, 6291,
-5777, 623, 1181, 1238, 1179, 6846, 3272, 6847, 8037, 3164, 3273,
-5778, 66, 211, 210, 888, 6335, 1447, 7854, 5821, 2034, 2033,
-5779, 558, 1204, 1151, 554, 7699, 3093, 8038, 4744, 7734, 7429,
-5780, 766, 1357, 756, 1369, 7046, 6283, 5421, 7834, 1653, 6284,
-5781, 1263, 1207, 1274, 585, 3396, 3395, 1744, 6358, 5906, 5905,
-5782, 1145, 470, 551, 576, 6431, 4682, 7849, 5598, 4768, 4770,
-5783, 1176, 607, 1210, 598, 8035, 5995, 3301, 6899, 4881, 6388,
-5784, 858, 35, 181, 36, 6179, 8001, 1944, 7550, 1559, 7568,
-5785, 999, 840, 426, 972, 2403, 8039, 7290, 2405, 2329, 7170,
-5786, 59, 204, 203, 881, 7251, 1440, 8006, 7422, 2013, 2012,
-5787, 181, 35, 858, 180, 8001, 6179, 1944, 1417, 6180, 1943,
-5788, 297, 442, 441, 931, 4323, 4325, 4321, 5565, 7203, 5564,
-5789, 59, 881, 203, 58, 7422, 2012, 8006, 1582, 5597, 6171,
-5790, 847, 1004, 438, 437, 2418, 6953, 7380, 6838, 6839, 4313,
-5791, 1006, 541, 440, 1003, 7748, 4652, 7491, 2579, 5707, 7498,
-5792, 438, 929, 439, 1004, 7366, 7367, 4316, 6953, 2417, 6952,
-5793, 848, 125, 93, 126, 1924, 3641, 7465, 1923, 1479, 3642,
-5794, 868, 46, 45, 190, 6773, 1569, 6772, 1973, 7271, 6775,
-5795, 869, 46, 192, 47, 8040, 7989, 1977, 7901, 1570, 7259,
-5796, 703, 1346, 1355, 736, 7700, 1604, 7780, 5316, 6920, 6512,
-5797, 881, 59, 319, 58, 7422, 3938, 5595, 5597, 1582, 3939,
-5798, 25, 805, 168, 167, 7885, 1822, 3585, 3586, 1821, 1403,
-5799, 1109, 520, 413, 412, 6362, 4586, 7724, 6522, 4585, 4237,
-5800, 192, 46, 869, 191, 7989, 8040, 1977, 1428, 7990, 1976,
-5801, 789, 226, 12, 333, 7082, 3680, 7796, 7797, 4046, 3972,
-5802, 715, 1303, 1321, 675, 5867, 1736, 7257, 5228, 7962, 5987,
-5803, 393, 247, 978, 246, 4176, 7461, 7719, 4175, 3736, 7459,
-5804, 962, 806, 807, 233, 2297, 1829, 2298, 7812, 7813, 8022,
-5805, 213, 68, 67, 916, 6270, 1591, 7995, 2104, 6197, 6195,
-5806, 392, 973, 821, 904, 7453, 2330, 7641, 7642, 2340, 2159,
-5807, 214, 69, 834, 917, 7079, 6211, 1893, 2107, 6986, 2172,
-5808, 63, 831, 914, 266, 8010, 2169, 5583, 3791, 8011, 5582,
-5809, 1264, 1226, 1197, 498, 2985, 3258, 3363, 6010, 6810, 6009,
-5810, 1221, 1108, 1110, 525, 3179, 2776, 3180, 7150, 7358, 7357,
-5811, 215, 69, 892, 214, 8041, 8007, 2046, 1451, 7079, 2045,
-5812, 324, 68, 891, 69, 3949, 7919, 6641, 3948, 1592, 7920,
-5813, 617, 1226, 1264, 498, 6808, 2985, 7227, 4911, 6810, 6010,
-5814, 23, 165, 22, 338, 3582, 3579, 1515, 3981, 6279, 3982,
-5815, 232, 803, 23, 338, 5651, 6278, 3693, 4079, 6280, 3981,
-5816, 1273, 752, 1318, 761, 6901, 7898, 3171, 6298, 5423, 6297,
-5817, 313, 46, 869, 47, 3927, 8040, 7634, 3926, 1570, 7901,
-5818, 368, 333, 946, 477, 4115, 7968, 7965, 4432, 4431, 7917,
-5819, 1218, 1217, 595, 1190, 3162, 6749, 6495, 3178, 3433, 6053,
-5820, 1110, 525, 418, 524, 7357, 4601, 5919, 5936, 4603, 4599,
-5821, 822, 904, 246, 189, 2191, 7460, 7458, 1870, 2080, 7659,
-5822, 726, 1289, 1297, 1340, 7364, 3192, 6594, 5968, 3193, 3131,
-5823, 567, 1126, 1227, 1127, 7318, 3068, 5608, 7321, 2832, 3212,
-5824, 45, 189, 867, 190, 7874, 1970, 6398, 6775, 1426, 1971,
-5825, 680, 1262, 627, 673, 6256, 6243, 5164, 5165, 6277, 5095,
-5826, 368, 477, 946, 1078, 4432, 7917, 7965, 5585, 5586, 2673,
-5827, 1129, 1028, 1130, 488, 2837, 2839, 2841, 7503, 5999, 6695,
-5828, 1130, 1029, 1131, 488, 2840, 2842, 2844, 6695, 5997, 7501,
-5829, 1310, 673, 690, 1248, 6714, 5155, 8042, 3514, 8025, 7761,
-5830, 828, 985, 260, 259, 2362, 6102, 6103, 6327, 6111, 3775,
-5831, 1034, 318, 1035, 465, 7767, 7451, 2511, 7708, 4396, 7452,
-5832, 407, 260, 1057, 406, 4217, 7993, 7413, 4219, 4215, 6395,
-5833, 1131, 1029, 462, 488, 2842, 5784, 5782, 7501, 5997, 4476,
-5834, 1259, 686, 1221, 630, 6289, 7060, 3358, 6291, 5140, 6730,
-5835, 1321, 1324, 1348, 750, 1738, 1696, 1722, 7258, 7904, 6614,
-5836, 745, 1294, 734, 1270, 7640, 6320, 5390, 6811, 3535, 6247,
-5837, 1130, 1228, 1129, 488, 3217, 3216, 2841, 6695, 6693, 7503,
-5838, 1208, 1274, 616, 610, 3398, 5555, 5553, 5619, 5763, 4909,
-5839, 1129, 1228, 492, 488, 3216, 6677, 7502, 7503, 6693, 4505,
-5840, 975, 244, 903, 820, 6212, 6213, 2334, 2335, 6529, 2158,
-5841, 483, 1093, 962, 1092, 7137, 2723, 7398, 7397, 2725, 2721,
-5842, 705, 1173, 1112, 1236, 7845, 2990, 5756, 5757, 3251, 3250,
-5843, 869, 313, 349, 46, 7634, 4100, 7698, 8040, 3927, 4010,
-5844, 869, 46, 868, 191, 8040, 6773, 1978, 1976, 7990, 1974,
-5845, 1184, 587, 1188, 501, 6089, 6034, 3173, 6660, 4808, 7631,
-5846, 538, 1054, 537, 435, 6311, 7368, 4643, 4641, 7175, 4639,
-5847, 903, 245, 42, 244, 7768, 3728, 6655, 6213, 3730, 3726,
-5848, 500, 388, 1100, 499, 4521, 7516, 7517, 4523, 4520, 7958,
-5849, 982, 401, 826, 254, 5992, 5991, 2357, 6879, 4199, 6877,
-5850, 855, 104, 140, 139, 6945, 3667, 1937, 1938, 3666, 1493,
-5851, 1341, 1347, 1305, 728, 1690, 1743, 1742, 8043, 7286, 8044,
-5852, 868, 46, 869, 349, 6773, 8040, 1978, 5509, 4010, 7698,
-5853, 659, 1305, 722, 728, 6968, 7822, 5256, 5278, 8044, 5279,
-5854, 659, 733, 1341, 728, 5301, 7548, 6789, 5278, 5302, 8043,
-5855, 989, 831, 265, 266, 2374, 7575, 5578, 5579, 8011, 3793,
-5856, 1305, 1347, 722, 728, 1743, 7285, 7822, 8044, 7286, 5279,
-5857, 1140, 1039, 1141, 490, 2870, 2872, 2874, 6128, 7564, 6127,
-5858, 1377, 207, 264, 62, 7678, 7809, 6709, 7573, 7622, 3786,
-5859, 914, 831, 989, 266, 2169, 2374, 2373, 5582, 8011, 5579,
-5860, 1304, 1344, 711, 1337, 2728, 8045, 6925, 2982, 1731, 7647,
-5861, 403, 1104, 513, 512, 6477, 5544, 4562, 4561, 7314, 4564,
-5862, 602, 1144, 1234, 576, 7401, 3239, 7853, 4861, 5599, 5600,
-5863, 362, 325, 473, 1049, 4072, 4420, 4419, 7551, 6610, 6608,
-5864, 269, 916, 67, 270, 6804, 6195, 3801, 3805, 6196, 3803,
-5865, 1299, 690, 1310, 699, 7680, 8042, 3155, 7661, 5181, 6540,
-5866, 605, 1201, 648, 1267, 6532, 6533, 5009, 7091, 3463, 6489,
-5867, 1045, 323, 890, 360, 6177, 7244, 2540, 7504, 4070, 7246,
-5868, 945, 789, 790, 333, 2246, 1778, 2247, 7967, 7797, 7686,
-5869, 1079, 570, 1078, 477, 8005, 5584, 2677, 7915, 4741, 5586,
-5870, 712, 1344, 711, 1304, 7942, 8045, 5219, 7129, 2728, 6925,
-5871, 66, 833, 67, 269, 6333, 6800, 1590, 3800, 6805, 3801,
-5872, 947, 477, 227, 369, 7916, 4430, 6100, 6792, 4433, 4118,
-5873, 471, 323, 1045, 360, 4415, 6177, 5629, 4414, 4070, 7504,
-5874, 1079, 1078, 946, 477, 2677, 2673, 2675, 7915, 5586, 7917,
-5875, 944, 226, 945, 368, 6221, 8019, 2248, 5745, 4116, 5744,
-5876, 219, 837, 75, 74, 1900, 7121, 7119, 7307, 7775, 1598,
-5877, 580, 1081, 369, 1080, 6902, 6437, 4791, 7604, 2683, 7928,
-5878, 558, 1152, 473, 1151, 7220, 7219, 4698, 8038, 2907, 7110,
-5879, 214, 68, 891, 213, 6783, 7919, 2043, 1450, 6270, 2042,
-5880, 558, 1205, 1152, 1204, 7443, 3096, 7220, 7699, 3099, 3094,
-5881, 253, 982, 254, 400, 5761, 6879, 3757, 4196, 5738, 4197,
-5882, 1052, 896, 327, 363, 2560, 7305, 5940, 5939, 7316, 4097,
-5883, 413, 266, 989, 412, 4235, 5579, 7402, 4237, 4233, 5580,
-5884, 1364, 1368, 1349, 774, 1622, 1621, 1623, 6485, 6479, 7471,
-5885, 1243, 1258, 594, 593, 3343, 6346, 6345, 6637, 7521, 4833,
-5886, 532, 531, 1001, 1189, 4624, 6228, 6293, 5983, 6229, 3037,
-5887, 527, 1218, 595, 1190, 6494, 6495, 4837, 6306, 3178, 6053,
-5888, 375, 339, 804, 960, 4129, 5615, 5522, 5524, 5494, 2291,
-5889, 856, 937, 1012, 343, 2218, 2438, 2437, 8030, 7828, 7540,
-5890, 369, 598, 580, 1080, 4848, 4862, 4791, 7928, 6900, 7604,
-5891, 856, 343, 1012, 237, 8030, 7540, 2437, 6580, 3994, 6227,
-5892, 1055, 520, 1182, 521, 7725, 6363, 3017, 7923, 4591, 7148,
-5893, 1001, 531, 428, 427, 6228, 4621, 7818, 6577, 4620, 4283,
-5894, 1287, 1304, 1271, 665, 3267, 3492, 3438, 6931, 6926, 6697,
-5895, 1198, 619, 1271, 652, 6704, 6950, 3386, 6705, 5029, 6698,
-5896, 1198, 1271, 1227, 652, 3386, 3385, 3215, 6705, 6698, 6702,
-5897, 328, 898, 1013, 899, 5845, 2445, 5849, 5848, 2068, 2442,
-5898, 219, 74, 75, 327, 7307, 1598, 7119, 7304, 3955, 3954,
-5899, 478, 939, 224, 367, 7801, 6987, 4436, 4437, 6752, 4113,
-5900, 897, 898, 75, 220, 2065, 5844, 5843, 2061, 2063, 7120,
-5901, 1329, 754, 1297, 1340, 7884, 6606, 3130, 1680, 7757, 3131,
-5902, 1297, 754, 726, 1340, 6606, 5370, 6594, 3131, 7757, 5968,
-5903, 1329, 777, 780, 754, 7288, 5488, 7287, 7884, 5468, 5485,
-5904, 758, 1329, 780, 754, 7945, 7287, 5486, 5480, 7884, 5485,
-5905, 1161, 972, 569, 531, 2937, 7171, 6238, 6230, 8046, 4749,
-5906, 569, 972, 427, 531, 7171, 6579, 4739, 4749, 8046, 4620,
-5907, 1099, 542, 1006, 541, 7275, 6225, 2746, 6665, 4656, 7748,
-5908, 1001, 972, 1161, 531, 2410, 2937, 2939, 6228, 8046, 6230,
-5909, 1353, 721, 725, 1324, 6553, 5283, 7633, 1697, 6549, 6634,
-5910, 1007, 543, 1164, 544, 7063, 6260, 2949, 7867, 4663, 6259,
-5911, 1255, 1294, 734, 761, 3461, 6320, 7379, 6296, 6322, 5401,
-5912, 56, 878, 879, 201, 7839, 2008, 7895, 6331, 2004, 2006,
-5913, 910, 828, 259, 985, 2197, 6327, 6348, 2363, 2362, 6111,
-5914, 826, 255, 254, 401, 6982, 3760, 6877, 5991, 4200, 4199,
-5915, 727, 1327, 1265, 752, 7836, 3448, 6393, 5363, 7206, 6394,
-5916, 1068, 543, 1164, 1007, 6514, 6260, 2950, 2628, 7063, 2949,
-5917, 427, 972, 1001, 531, 6579, 2410, 6577, 4620, 8046, 6228,
-5918, 198, 255, 256, 53, 6452, 3763, 7716, 6451, 3759, 3761,
-5919, 1310, 673, 1308, 701, 6714, 6273, 3224, 7955, 5188, 6274,
-5920, 670, 608, 1292, 586, 5088, 6058, 6056, 5090, 4885, 6686,
-5921, 539, 1170, 636, 1171, 7131, 6303, 4965, 7594, 2987, 6762,
-5922, 1318, 1294, 1255, 761, 3214, 3461, 3538, 6297, 6322, 6296,
-5923, 1318, 765, 1294, 761, 7588, 6321, 3214, 6297, 5417, 6322,
-5924, 747, 706, 1192, 1236, 5343, 5799, 5938, 5556, 5755, 3252,
-5925, 758, 1300, 1329, 754, 6814, 3125, 7945, 5480, 7944, 7884,
-5926, 1351, 739, 757, 768, 6441, 5387, 6434, 7311, 5428, 5427,
-5927, 1253, 689, 1297, 741, 7123, 6595, 3467, 7600, 5327, 6596,
-5928, 1255, 734, 748, 761, 7379, 5369, 7378, 6296, 5401, 5400,
-5929, 659, 645, 647, 1285, 5062, 5001, 5063, 7511, 5539, 5538,
-5930, 691, 1193, 589, 621, 7717, 7208, 5157, 5158, 6092, 4815,
-5931, 507, 621, 1107, 622, 4922, 7535, 6016, 4923, 4924, 6018,
-5932, 306, 855, 450, 305, 6430, 8047, 4348, 3913, 7979, 4347,
-5933, 1006, 542, 440, 541, 6225, 4654, 7491, 7748, 4656, 4652,
-5934, 683, 1238, 743, 693, 6863, 7896, 5331, 5265, 6862, 5330,
-5935, 1042, 322, 469, 358, 7879, 4410, 6029, 7400, 4092, 4407,
-5936, 1330, 756, 1343, 735, 7938, 6970, 1678, 7982, 5379, 7820,
-5937, 678, 640, 1220, 709, 5214, 6370, 6368, 5234, 5212, 6152,
-5938, 714, 619, 1286, 687, 5222, 6946, 7843, 5225, 5144, 6069,
-5939, 1111, 415, 990, 414, 5516, 5517, 2778, 6020, 4243, 6019,
-5940, 749, 1300, 758, 754, 7629, 6814, 5452, 5447, 7944, 5480,
-5941, 471, 470, 1044, 323, 4483, 7147, 6176, 4415, 4413, 6178,
-5942, 749, 741, 1297, 754, 5351, 6596, 7597, 5447, 5371, 6606,
-5943, 1299, 740, 1342, 1333, 7409, 6829, 3142, 3141, 8000, 1695,
-5944, 1086, 565, 1178, 1085, 6378, 5908, 3003, 2704, 6380, 3135,
-5945, 1178, 1213, 649, 1087, 3139, 6138, 5907, 3004, 3137, 7506,
-5946, 540, 541, 638, 1166, 4653, 4971, 4970, 5704, 5705, 5863,
-5947, 676, 719, 697, 1280, 5239, 5242, 5175, 6351, 8048, 6356,
-5948, 580, 1080, 1176, 1081, 7604, 2999, 7603, 6902, 2683, 3000,
-5949, 1330, 735, 1343, 1295, 7982, 7820, 1678, 1685, 7454, 1684,
-5950, 664, 1316, 1282, 669, 7576, 3113, 7889, 5172, 7738, 6048,
-5951, 572, 1215, 612, 1216, 7570, 6842, 4895, 7553, 3154, 7892,
-5952, 1350, 739, 1351, 1344, 6443, 6441, 1649, 1702, 6845, 1703,
-5953, 1337, 1350, 739, 757, 1700, 6443, 6844, 6555, 6436, 5387,
-5954, 1337, 757, 739, 711, 6555, 5387, 6844, 7647, 5383, 5324,
-5955, 787, 332, 943, 366, 7984, 8049, 2240, 5889, 4111, 5888,
-5956, 918, 274, 420, 993, 6670, 4257, 7056, 2385, 7066, 6916,
-5957, 742, 775, 760, 1358, 5458, 5457, 5396, 6467, 6268, 6465,
-5958, 274, 993, 421, 420, 7066, 7074, 4259, 4257, 6916, 4261,
-5959, 1275, 610, 1210, 717, 5617, 7196, 3401, 5964, 5232, 5963,
-5960, 730, 662, 1291, 718, 5287, 7727, 8050, 5290, 5238, 7560,
-5961, 1328, 662, 1276, 1278, 7726, 7791, 3266, 3259, 7728, 3408,
-5962, 396, 250, 823, 249, 4185, 7042, 7921, 4184, 3745, 6751,
-5963, 954, 799, 230, 798, 2274, 6996, 5604, 2273, 1805, 6999,
-5964, 19, 798, 160, 336, 8051, 1800, 3573, 3977, 7000, 7064,
-5965, 230, 798, 19, 336, 6999, 8051, 3689, 4077, 7000, 3977,
-5966, 1155, 1191, 1173, 633, 3045, 3047, 2991, 7742, 6798, 8031,
-5967, 161, 160, 19, 798, 1396, 3573, 3572, 1801, 1800, 8051,
-5968, 450, 855, 1010, 305, 8047, 2434, 6433, 4347, 7979, 7190,
-5969, 230, 161, 19, 798, 6785, 3572, 3689, 6999, 1801, 8051,
-5970, 572, 1091, 1215, 1092, 7974, 3147, 7570, 7555, 2722, 3149,
-5971, 639, 1099, 638, 541, 6041, 5865, 4975, 4973, 6665, 4971,
-5972, 316, 1030, 1031, 875, 5806, 2499, 8004, 6876, 2495, 2497,
-5973, 964, 1093, 963, 377, 2726, 2724, 2305, 7032, 7033, 7140,
-5974, 403, 1104, 512, 983, 6477, 7314, 4561, 6478, 2758, 7315,
-5975, 28, 809, 172, 171, 7014, 1834, 3592, 3593, 1833, 1407,
-5976, 341, 809, 172, 28, 6317, 1834, 5652, 3988, 7014, 3592,
-5977, 1134, 1229, 1230, 552, 3222, 3253, 3223, 6536, 8052, 6967,
-5978, 1087, 565, 1178, 1086, 6379, 5908, 3004, 2707, 6378, 3003,
-5979, 649, 565, 1178, 1087, 5012, 5908, 5907, 7506, 6379, 3004,
-5980, 208, 831, 914, 63, 1887, 2169, 2101, 7722, 8010, 5583,
-5981, 1330, 756, 735, 732, 7938, 5379, 7982, 6499, 5378, 5314,
-5982, 1261, 600, 645, 552, 7639, 4995, 5541, 7773, 4853, 4996,
-5983, 910, 258, 55, 257, 6373, 3767, 6764, 5975, 3769, 3765,
-5984, 744, 742, 724, 1322, 5336, 5329, 5334, 7825, 8012, 7626,
-5985, 694, 1241, 625, 695, 6105, 7618, 5169, 5266, 6840, 5267,
-5986, 208, 831, 63, 62, 1887, 8010, 7722, 7623, 7574, 1586,
-5987, 63, 831, 265, 62, 8010, 7575, 3789, 1586, 7574, 3788,
-5988, 842, 113, 83, 114, 1912, 3619, 7158, 1911, 1467, 3620,
-5989, 406, 985, 1057, 1106, 6110, 2582, 6395, 6396, 2763, 2765,
-5990, 1230, 552, 1229, 1261, 6967, 8052, 3253, 3350, 7773, 3351,
-5991, 733, 774, 1349, 764, 5449, 7471, 7469, 5412, 5450, 6447,
-5992, 429, 998, 923, 842, 5715, 2400, 5714, 6954, 2399, 2222,
-5993, 285, 998, 429, 842, 7816, 5715, 4285, 7157, 2399, 6954,
-5994, 671, 1345, 1309, 732, 7016, 1747, 6292, 5295, 7935, 6500,
-5995, 703, 736, 1355, 721, 5316, 6512, 7780, 5248, 5317, 8053,
-5996, 1272, 618, 1202, 1290, 6904, 8034, 3389, 3452, 7929, 3453,
-5997, 1202, 618, 561, 1290, 8034, 5010, 6825, 3453, 7929, 6827,
-5998, 1229, 600, 1261, 552, 7868, 7639, 3351, 8052, 4853, 7773,
-5999, 935, 853, 447, 303, 2188, 5725, 7159, 7697, 7991, 4339,
-6000, 935, 303, 447, 448, 7697, 4339, 7159, 6123, 4341, 4343,
-6001, 375, 1091, 571, 376, 8054, 7975, 4748, 4450, 7610, 4747,
-6002, 303, 853, 447, 302, 7991, 5725, 4339, 3904, 7992, 4338,
-6003, 1319, 1312, 702, 1311, 3377, 6004, 6005, 3210, 3529, 5986,
-6004, 712, 739, 711, 1344, 5325, 5324, 5219, 7942, 6845, 8045,
-6005, 702, 724, 1319, 1311, 5263, 7388, 6005, 5986, 5686, 3210,
-6006, 1102, 399, 400, 982, 6997, 4198, 5737, 2752, 5760, 5738,
-6007, 1121, 1019, 384, 1120, 2812, 5950, 5949, 2814, 2810, 7584,
-6008, 902, 40, 185, 39, 7035, 5900, 2076, 7036, 1563, 8055,
-6009, 186, 863, 185, 40, 1959, 1958, 1422, 5901, 7268, 5900,
-6010, 1066, 926, 433, 289, 2618, 5817, 5815, 7899, 7863, 4297,
-6011, 41, 347, 42, 864, 4007, 4006, 1565, 7130, 5793, 5792,
-6012, 646, 1225, 1195, 1257, 6627, 3356, 7533, 6630, 3355, 3341,
-6013, 187, 41, 42, 864, 7625, 1565, 7209, 1962, 7130, 5792,
-6014, 53, 876, 198, 875, 7715, 1997, 6451, 7512, 1999, 1995,
-6015, 351, 194, 871, 872, 7632, 1983, 6589, 6590, 1985, 1987,
-6016, 53, 875, 197, 52, 7512, 1994, 6449, 1576, 6875, 7269,
-6017, 353, 876, 53, 875, 5502, 7715, 4019, 5501, 1999, 7512,
-6018, 53, 316, 353, 875, 3932, 4063, 4019, 7512, 6876, 5501,
-6019, 52, 316, 53, 875, 3933, 3932, 1576, 6875, 6876, 7512,
-6020, 53, 52, 197, 255, 1576, 7269, 6449, 3759, 3758, 6450,
-6021, 757, 1350, 1365, 1362, 6436, 1642, 6435, 6933, 1643, 1637,
-6022, 1065, 435, 1066, 434, 6421, 6454, 2650, 6422, 4304, 7341,
-6023, 1198, 1228, 492, 1129, 3219, 6677, 7882, 3071, 3216, 7502,
-6024, 845, 290, 88, 289, 6737, 3863, 7161, 7163, 3865, 3861,
-6025, 64, 887, 209, 886, 6192, 2030, 7670, 6186, 2032, 2028,
-6026, 317, 354, 55, 878, 4064, 4021, 3934, 7526, 7527, 7840,
-6027, 701, 1322, 1308, 1339, 7939, 3227, 6274, 6911, 1686, 3225,
-6028, 1198, 1129, 492, 1128, 3071, 7502, 7882, 3070, 2838, 7827,
-6029, 248, 905, 978, 247, 6463, 2345, 7954, 3739, 6656, 7461,
-6030, 571, 1091, 1090, 1215, 7975, 2719, 7313, 6841, 3147, 3146,
-6031, 1101, 1194, 591, 1224, 3055, 6607, 6513, 3196, 3195, 6976,
-6032, 228, 949, 371, 794, 6894, 6889, 4122, 5959, 2259, 7247,
-6033, 690, 673, 1310, 699, 5155, 6714, 8042, 5181, 5180, 6540,
-6034, 1141, 490, 468, 556, 6127, 4487, 8056, 6726, 4693, 4692,
-6035, 285, 842, 83, 114, 7157, 7158, 3848, 6168, 1911, 3620,
-6036, 401, 982, 1113, 400, 5992, 2788, 7444, 4201, 5738, 5739,
-6037, 1343, 756, 770, 735, 6970, 5432, 6969, 7820, 5379, 5433,
-6038, 897, 220, 75, 219, 2061, 7120, 5843, 2060, 1456, 7119,
-6039, 897, 1053, 364, 898, 2563, 5636, 5841, 2065, 2564, 5842,
-6040, 961, 376, 339, 233, 5602, 4132, 5495, 7811, 4131, 4080,
-6041, 1142, 556, 1141, 468, 7494, 6726, 2877, 6880, 4692, 8056,
-6042, 1116, 511, 401, 1113, 5513, 4556, 7438, 2944, 5514, 7444,
-6043, 1052, 896, 363, 1051, 2560, 7316, 5939, 2562, 2558, 6419,
-6044, 947, 477, 946, 227, 7916, 7917, 2254, 6100, 4430, 6099,
-6045, 363, 895, 73, 326, 7798, 7862, 4039, 4073, 6683, 3952,
-6046, 254, 51, 52, 908, 3755, 1575, 3756, 6878, 8003, 7274,
-6047, 947, 369, 1079, 477, 6792, 7927, 2676, 7916, 4433, 7915,
-6048, 20, 799, 162, 161, 6779, 1804, 3574, 3575, 1803, 1397,
-6049, 21, 801, 231, 164, 7301, 5870, 3691, 3578, 1810, 7195,
-6050, 196, 51, 52, 874, 7803, 1575, 7273, 1991, 7280, 6874,
-6051, 253, 908, 825, 51, 7937, 2163, 6719, 3753, 8003, 7804,
-6052, 254, 908, 253, 51, 6878, 7937, 3757, 3755, 8003, 3753,
-6053, 342, 235, 812, 30, 4055, 7300, 6722, 3990, 3698, 7536,
-6054, 401, 1113, 511, 400, 7444, 5514, 4556, 4201, 5739, 4555,
-6055, 485, 967, 968, 812, 7337, 2317, 5811, 7986, 2313, 2315,
-6056, 485, 968, 342, 812, 5811, 5915, 4457, 7986, 2315, 6722,
-6057, 979, 823, 396, 906, 2348, 7921, 6543, 2347, 2161, 6546,
-6058, 74, 73, 219, 919, 1597, 6098, 7307, 6027, 6028, 2110,
-6059, 47, 906, 193, 48, 7041, 2084, 7260, 1571, 7953, 6585,
-6060, 136, 101, 303, 102, 3660, 3902, 7696, 3661, 1551, 3903,
-6061, 623, 509, 510, 1179, 4925, 4554, 4926, 8037, 7534, 5658,
-6062, 302, 101, 853, 135, 3900, 7180, 7992, 7160, 3659, 1934,
-6063, 275, 1062, 836, 919, 7072, 2603, 7075, 7261, 2605, 2174,
-6064, 622, 1179, 1107, 509, 7345, 3027, 6018, 4820, 7534, 6971,
-6065, 848, 1003, 439, 929, 2414, 6941, 7369, 2210, 2415, 7367,
-6066, 724, 742, 1319, 1322, 5329, 6466, 7388, 7626, 8012, 1714,
-6067, 724, 1322, 1308, 701, 7626, 3227, 5684, 5333, 7939, 6274,
-6068, 441, 931, 1068, 1006, 5564, 2624, 6222, 6224, 2424, 2625,
-6069, 1250, 642, 679, 643, 5728, 5114, 6854, 7372, 4988, 5115,
-6070, 1177, 651, 1211, 1082, 7440, 6199, 3128, 3127, 7538, 3122,
-6071, 433, 288, 289, 926, 4296, 3862, 4297, 5817, 7877, 7863,
-6072, 120, 845, 88, 119, 1917, 7161, 3631, 1473, 1918, 3630,
-6073, 1066, 290, 845, 289, 6453, 6737, 2617, 7899, 3865, 7163,
-6074, 1002, 536, 1065, 434, 5838, 7476, 2781, 8024, 4637, 6422,
-6075, 925, 432, 288, 287, 5876, 4294, 7561, 5874, 4293, 3859,
-6076, 778, 744, 1372, 772, 5469, 7830, 6994, 5472, 5466, 6475,
-6077, 478, 563, 1073, 497, 4781, 5644, 7644, 4780, 4782, 7645,
-6078, 1176, 580, 1211, 607, 7603, 8057, 3123, 8035, 4880, 6198,
-6079, 367, 939, 224, 783, 6752, 6987, 4113, 6882, 2228, 6988,
-6080, 997, 1072, 386, 818, 2642, 7602, 7044, 2397, 2639, 7043,
-6081, 34, 1375, 237, 1, 6506, 7858, 3705, 1557, 7187, 3704,
-6082, 3, 1375, 107, 1, 6763, 6424, 1460, 3606, 7187, 3607,
-6083, 1339, 744, 701, 1322, 6912, 5335, 6911, 1686, 7825, 7939,
-6084, 1331, 1355, 1353, 721, 1603, 1609, 1689, 6554, 8053, 6553,
-6085, 1076, 1207, 1075, 575, 3106, 3105, 2668, 5890, 7078, 5892,
-6086, 954, 953, 480, 1084, 2275, 5607, 5605, 2696, 2694, 7792,
-6087, 738, 1355, 736, 721, 6666, 6512, 5323, 5321, 8053, 5317,
-6088, 59, 58, 203, 829, 1582, 6171, 8006, 7887, 7994, 1884,
-6089, 778, 1372, 769, 772, 6994, 6473, 5474, 5472, 6475, 5438,
-6090, 984, 983, 403, 827, 2593, 6478, 6476, 2361, 2358, 6557,
-6091, 417, 270, 991, 416, 4247, 7132, 7621, 4249, 4245, 7114,
-6092, 483, 1093, 572, 493, 7137, 7554, 4751, 4507, 7031, 4753,
-6093, 418, 271, 991, 417, 4250, 7217, 5918, 4252, 4248, 7621,
-6094, 549, 480, 372, 1084, 4677, 4464, 4678, 7437, 7792, 7417,
-6095, 969, 379, 424, 1097, 7344, 4617, 5895, 2741, 5794, 5627,
-6096, 1162, 993, 1108, 420, 2941, 2768, 2948, 8032, 6916, 6915,
-6097, 17, 796, 159, 158, 7985, 1795, 3569, 3567, 1794, 1394,
-6098, 961, 1091, 960, 376, 2718, 2717, 2296, 5602, 7610, 5601,
-6099, 17, 796, 795, 335, 7985, 1796, 6231, 3975, 7606, 6232,
-6100, 572, 612, 615, 1216, 4895, 4904, 4903, 7553, 7892, 7611,
-6101, 1229, 1135, 553, 552, 3220, 7387, 7933, 8052, 7787, 4788,
-6102, 263, 409, 830, 410, 4224, 5886, 5691, 4226, 4228, 5922,
-6103, 484, 377, 568, 964, 4455, 4734, 4736, 7006, 7032, 7861,
-6104, 551, 618, 561, 1202, 4912, 5010, 4709, 7736, 8034, 6825,
-6105, 1073, 1115, 367, 497, 2795, 6753, 7646, 7645, 7799, 4726,
-6106, 1001, 427, 428, 841, 6577, 4283, 7818, 2408, 7783, 5711,
-6107, 572, 1215, 571, 612, 7570, 6841, 4794, 4895, 6842, 4896,
-6108, 1094, 1093, 615, 1217, 2731, 7608, 5525, 3158, 3157, 5526,
-6109, 428, 841, 427, 283, 5711, 7783, 4283, 4281, 5713, 4279,
-6110, 681, 1247, 656, 1191, 6241, 5786, 5125, 7864, 3305, 5787,
-6111, 37, 818, 181, 182, 8029, 1862, 7106, 6423, 1861, 1418,
-6112, 1216, 664, 1217, 1283, 7890, 6750, 3156, 3431, 7577, 3432,
-6113, 664, 686, 1316, 723, 5150, 6344, 7576, 5258, 5257, 5671,
-6114, 1171, 1236, 1192, 706, 3249, 3252, 3049, 7959, 5755, 5799,
-6115, 297, 850, 298, 442, 5834, 5833, 3889, 4323, 6940, 4324,
-6116, 1008, 851, 1067, 444, 2629, 2623, 2644, 5768, 5767, 7777,
-6117, 444, 300, 933, 851, 4330, 7479, 5766, 5767, 7951, 2186,
-6118, 1171, 1192, 636, 706, 3049, 5798, 6762, 7959, 5799, 5203,
-6119, 283, 112, 284, 841, 8058, 7293, 3847, 5713, 1909, 5712,
-6120, 284, 112, 283, 82, 7293, 8058, 3847, 3845, 3617, 3843,
-6121, 82, 112, 283, 81, 3617, 8058, 3843, 1531, 3616, 3842,
-6122, 748, 1246, 1192, 707, 7685, 3307, 6096, 5346, 6113, 5800,
-6123, 405, 1106, 513, 984, 6644, 5542, 4565, 6118, 2764, 7475,
-6124, 318, 879, 880, 57, 7651, 2011, 7650, 3936, 7900, 6326,
-6125, 513, 1104, 1174, 512, 5544, 2992, 7472, 4564, 7314, 6458,
-6126, 111, 112, 283, 841, 1465, 8058, 7156, 1910, 1909, 5713,
-6127, 457, 530, 1125, 1124, 4618, 8014, 6276, 8002, 6729, 2826,
-6128, 615, 493, 572, 1093, 4902, 4753, 4903, 7608, 7031, 7554,
-6129, 270, 1061, 269, 916, 7133, 7556, 3805, 6196, 2601, 6804,
-6130, 283, 112, 111, 81, 8058, 1465, 7156, 3842, 3616, 3615,
-6131, 293, 123, 292, 91, 7788, 7709, 3874, 3872, 3637, 3870,
-6132, 1007, 443, 932, 850, 7174, 5741, 2426, 2427, 6936, 2185,
-6133, 42, 311, 43, 865, 3923, 3922, 1566, 5781, 7292, 5780,
-6134, 230, 480, 373, 954, 4444, 4467, 4126, 5604, 5605, 5620,
-6135, 336, 797, 229, 952, 7065, 6592, 4049, 6742, 2268, 6741,
-6136, 966, 378, 810, 235, 7023, 7109, 2309, 6037, 4135, 7054,
-6137, 42, 245, 903, 821, 3728, 7768, 6655, 7210, 7769, 2155,
-6138, 965, 964, 484, 568, 2308, 7006, 7005, 5638, 7861, 4736,
-6139, 1115, 454, 1053, 938, 6756, 6061, 2796, 2793, 6757, 2655,
-6140, 292, 847, 123, 293, 7710, 1922, 7709, 3874, 7381, 7788,
-6141, 292, 90, 91, 123, 3869, 1540, 3870, 7709, 3636, 3637,
-6142, 973, 244, 391, 245, 6214, 4169, 7391, 7770, 3730, 4170,
-6143, 242, 902, 243, 977, 7034, 7689, 3724, 6888, 2342, 6861,
-6144, 380, 1017, 1018, 346, 7096, 2460, 7097, 4139, 7964, 7254,
-6145, 380, 1018, 451, 346, 7097, 7569, 4352, 4139, 7254, 4351,
-6146, 241, 819, 901, 38, 6149, 2157, 6148, 3716, 5925, 6163,
-6147, 1185, 629, 1260, 1182, 7656, 5590, 3346, 3172, 7149, 3365,
-6148, 462, 1030, 352, 1029, 5783, 5805, 4389, 5784, 2496, 7500,
-6149, 352, 315, 462, 1029, 4062, 4390, 4389, 7500, 5996, 5784,
-6150, 1186, 640, 639, 709, 6518, 4978, 6517, 6151, 5212, 5211,
-6151, 822, 189, 45, 190, 1870, 7874, 6658, 1869, 1426, 6775,
-6152, 1123, 460, 1022, 1124, 5746, 5633, 2819, 2823, 5634, 2821,
-6153, 352, 1030, 316, 874, 5805, 5806, 4086, 7270, 2494, 6873,
-6154, 122, 90, 292, 123, 3635, 3869, 7355, 1476, 3636, 7709,
-6155, 427, 283, 922, 282, 4279, 7784, 6578, 4278, 3844, 7165,
-6156, 921, 1005, 280, 839, 2423, 6352, 6636, 2116, 2421, 6353,
-6157, 1154, 569, 426, 456, 5789, 4738, 7169, 5790, 4737, 4714,
-6158, 1134, 1135, 1229, 552, 2856, 3220, 3222, 6536, 7787, 8052,
-6159, 546, 445, 446, 1069, 4667, 4337, 4668, 5735, 5736, 7371,
-6160, 100, 302, 934, 135, 3899, 7216, 7205, 3658, 7160, 2144,
-6161, 1010, 1183, 548, 1071, 3022, 6802, 5807, 2637, 3050, 5665,
-6162, 1010, 855, 936, 305, 2434, 2217, 2432, 7190, 7979, 7189,
-6163, 140, 937, 141, 105, 2151, 2150, 1494, 3668, 7926, 3669,
-6164, 309, 1017, 346, 862, 7212, 7964, 4056, 6159, 2456, 7510,
-6165, 370, 1025, 459, 313, 7966, 7530, 4380, 4119, 7636, 4379,
-6166, 346, 310, 40, 863, 4105, 3921, 4004, 7255, 5643, 7268,
-6167, 1341, 1305, 659, 728, 1742, 6968, 6789, 8043, 8044, 5278,
-6168, 468, 490, 1141, 1040, 4487, 6127, 8056, 7411, 7565, 2873,
-6169, 1231, 553, 1229, 1135, 7385, 7933, 3221, 3077, 7387, 3220,
-6170, 353, 875, 316, 1031, 5501, 6876, 4063, 5500, 2497, 8004,
-6171, 415, 269, 990, 268, 4242, 7239, 5517, 4241, 3802, 6831,
-6172, 191, 46, 190, 905, 7990, 7271, 1427, 2082, 6462, 2083,
-6173, 66, 888, 65, 359, 5821, 7450, 1589, 4030, 5820, 4031,
-6174, 1041, 468, 1142, 1040, 6881, 6880, 2876, 2529, 7411, 2875,
-6175, 1142, 468, 1141, 1040, 6880, 8056, 2877, 2875, 7411, 2873,
-6176, 576, 618, 1202, 1234, 4913, 8034, 6486, 5600, 7660, 3262,
-6177, 434, 290, 1066, 289, 4300, 6453, 7341, 4299, 3865, 7899,
-6178, 88, 120, 89, 290, 3631, 3632, 1538, 3863, 6833, 3864,
-6179, 100, 301, 99, 134, 3897, 3896, 1549, 3657, 7224, 3656,
-6180, 437, 292, 847, 928, 4308, 7710, 6838, 7178, 7711, 2224,
-6181, 697, 669, 1316, 723, 5250, 7738, 5670, 5320, 5270, 5671,
-6182, 473, 1050, 474, 326, 7266, 6598, 4493, 4421, 6691, 4423,
-6183, 537, 1054, 1112, 1065, 7368, 2782, 7467, 6420, 2615, 2783,
-6184, 191, 46, 868, 190, 7990, 6773, 1974, 1427, 7271, 1973,
-6185, 420, 992, 525, 419, 6914, 7359, 4604, 4258, 7617, 4602,
-6186, 1024, 457, 349, 370, 6275, 4371, 5508, 6739, 4373, 4120,
-6187, 942, 225, 787, 366, 7113, 7081, 2238, 5887, 4112, 5889,
-6188, 383, 368, 1077, 573, 4149, 5743, 7191, 4755, 4754, 7997,
-6189, 1076, 1207, 616, 1208, 3106, 5554, 7077, 3108, 3110, 5553,
-6190, 224, 784, 146, 783, 5700, 1758, 7823, 6988, 1760, 1756,
-6191, 383, 573, 1077, 1076, 4755, 7997, 7191, 5904, 7998, 2671,
-6192, 573, 1076, 383, 575, 7998, 5904, 4755, 4762, 5890, 4759,
-6193, 1062, 993, 1162, 421, 2604, 2941, 2940, 6064, 7074, 6063,
-6194, 678, 1237, 1220, 641, 5570, 3255, 6368, 5112, 5571, 6369,
-6195, 21, 800, 231, 801, 7204, 5871, 3691, 7301, 1811, 5870,
-6196, 1211, 651, 1177, 1278, 6199, 7440, 3128, 3409, 7740, 3410,
-6197, 373, 565, 1086, 1085, 4722, 6378, 7201, 5621, 6380, 2704,
-6198, 428, 923, 429, 996, 5764, 5714, 4286, 7819, 2393, 5716,
-6199, 1164, 641, 1172, 544, 6261, 7181, 2981, 6259, 4980, 7182,
-6200, 705, 634, 1112, 1155, 5199, 7468, 5756, 7846, 7478, 2920,
-6201, 1196, 1118, 1119, 599, 3061, 2808, 3062, 7676, 7675, 6166,
-6202, 1117, 574, 1206, 1161, 6237, 5956, 3102, 3060, 5957, 3101,
-6203, 1172, 642, 545, 641, 6254, 4983, 6253, 7181, 4985, 4982,
-6204, 85, 115, 286, 84, 3623, 7703, 3852, 1534, 3622, 3851,
-6205, 429, 285, 430, 998, 4285, 4287, 4289, 5715, 7816, 7487,
-6206, 430, 285, 924, 998, 4287, 6771, 5884, 7487, 7816, 2402,
-6207, 7, 145, 330, 783, 3546, 5972, 3964, 6758, 1755, 5971,
-6208, 922, 841, 111, 283, 2223, 1910, 2119, 7784, 5713, 7156,
-6209, 510, 509, 399, 1102, 4554, 4550, 4552, 5659, 6989, 6997,
-6210, 977, 389, 242, 974, 6095, 4163, 6888, 2343, 5679, 5677,
-6211, 421, 993, 1162, 420, 7074, 2941, 6063, 4261, 6916, 8032,
-6212, 1325, 719, 676, 1280, 6736, 5239, 6507, 3421, 8048, 6351,
-6213, 384, 1020, 1121, 458, 5951, 2813, 5949, 4376, 6086, 7211,
-6214, 1353, 1355, 738, 721, 1609, 6666, 6615, 6553, 8053, 5321,
-6215, 603, 1205, 1175, 1074, 7441, 3189, 6219, 5930, 3188, 2997,
-6216, 866, 311, 1021, 865, 7682, 7093, 2468, 1969, 7292, 2467,
-6217, 979, 1058, 396, 823, 2588, 6918, 6543, 2348, 2585, 7921,
-6218, 766, 1333, 753, 740, 7049, 8059, 5422, 5419, 8000, 5366,
-6219, 7, 6, 330, 145, 1499, 3965, 3964, 3546, 3543, 5972,
-6220, 603, 1207, 616, 575, 6220, 5554, 5031, 5004, 7078, 5142,
-6221, 1175, 558, 603, 585, 7442, 4864, 6219, 7225, 4804, 4901,
-6222, 563, 1073, 1205, 1074, 5644, 3098, 7805, 5646, 2660, 3188,
-6223, 1085, 577, 611, 1212, 7810, 4892, 6381, 3133, 6718, 6382,
-6224, 549, 1084, 1177, 1212, 7437, 3002, 7436, 6717, 3132, 3134,
-6225, 558, 585, 1204, 554, 4804, 8008, 7699, 4744, 4805, 7734,
-6226, 649, 1213, 1088, 1087, 6138, 3138, 6137, 7506, 3137, 2710,
-6227, 1140, 1039, 490, 1038, 2870, 7564, 6128, 2869, 2523, 7546,
-6228, 527, 1218, 528, 596, 6494, 6922, 4613, 4839, 6496, 4840,
-6229, 821, 904, 188, 246, 2159, 2081, 1867, 7643, 7460, 7658,
-6230, 1082, 651, 549, 1177, 7538, 5019, 6336, 3127, 7440, 7436,
-6231, 1175, 1204, 558, 585, 3308, 7699, 7442, 7225, 8008, 4804,
-6232, 1216, 664, 1282, 612, 7890, 7889, 3430, 7892, 5118, 7020,
-6233, 148, 331, 147, 8, 7394, 5667, 1383, 3549, 3967, 3547,
-6234, 1053, 1052, 327, 475, 2566, 5940, 5635, 5637, 5941, 4425,
-6235, 823, 192, 47, 906, 1871, 7259, 7040, 2161, 2085, 7041,
-6236, 542, 640, 639, 1168, 4976, 4978, 4974, 6516, 6520, 6519,
-6237, 493, 1094, 568, 964, 7303, 5640, 4735, 7030, 2729, 7861,
-6238, 1169, 643, 642, 1250, 6258, 4988, 5727, 3293, 7372, 5728,
-6239, 679, 642, 1250, 1237, 5114, 5728, 6854, 7310, 5572, 3323,
-6240, 512, 1104, 1174, 1116, 7314, 2992, 6458, 6459, 2799, 2993,
-6241, 1164, 1172, 1067, 544, 2981, 2980, 2953, 6259, 7182, 7778,
-6242, 1067, 1172, 545, 544, 2980, 6253, 7776, 7778, 7182, 4666,
-6243, 664, 669, 1282, 612, 5172, 6048, 7889, 5118, 5087, 7020,
-6244, 1293, 1235, 650, 1290, 3500, 7880, 6308, 3039, 3503, 7684,
-6245, 664, 1216, 1217, 615, 7890, 3156, 6750, 5117, 7611, 5526,
-6246, 990, 915, 267, 268, 2377, 6797, 7333, 6831, 6832, 3799,
-6247, 756, 766, 713, 1357, 5421, 5420, 5380, 6283, 7046, 7047,
-6248, 977, 389, 1163, 390, 6095, 6022, 3011, 6084, 4168, 6033,
-6249, 572, 1216, 615, 1093, 7553, 7611, 4903, 7554, 3153, 7608,
-6250, 667, 597, 650, 1293, 5081, 5018, 5082, 6744, 6310, 6308,
-6251, 405, 513, 404, 984, 4565, 4563, 4213, 6118, 7475, 5499,
-6252, 1364, 742, 775, 774, 6484, 5458, 6266, 6485, 5473, 5481,
-6253, 1196, 599, 644, 574, 7676, 4991, 6082, 7392, 4882, 4992,
-6254, 848, 93, 930, 126, 7465, 7463, 2183, 1923, 3642, 2137,
-6255, 427, 282, 922, 972, 4278, 7165, 6578, 6579, 7746, 2328,
-6256, 730, 1346, 703, 762, 7701, 7700, 5391, 5405, 6921, 5409,
-6257, 612, 664, 615, 1216, 5118, 5117, 4904, 7892, 7890, 7611,
-6258, 760, 780, 758, 1334, 5487, 5486, 5397, 6973, 6521, 6972,
-6259, 569, 574, 1161, 531, 4772, 5957, 6238, 4749, 4803, 6230,
-6260, 1351, 768, 757, 1365, 7311, 5427, 6434, 1648, 6265, 6435,
-6261, 1189, 1206, 1196, 574, 3104, 3175, 3314, 5955, 5956, 7392,
-6262, 704, 717, 1320, 730, 5339, 6906, 6372, 5340, 5288, 6562,
-6263, 1024, 1025, 370, 313, 2481, 7966, 6739, 7635, 7636, 4119,
-6264, 452, 1117, 1154, 569, 5532, 2913, 5788, 4740, 6236, 5789,
-6265, 730, 662, 1328, 1291, 5287, 7726, 6564, 8050, 7727, 2736,
-6266, 582, 578, 646, 1225, 4779, 4998, 4997, 6194, 6081, 6627,
-6267, 582, 1226, 1122, 1121, 6809, 3064, 7838, 6215, 3063, 2817,
-6268, 573, 1076, 616, 1208, 7998, 7077, 4908, 7999, 3108, 5553,
-6269, 1209, 610, 1210, 1275, 5618, 7196, 3120, 3400, 5617, 3401,
-6270, 1078, 570, 1209, 1208, 5584, 7434, 3115, 3111, 7435, 3117,
-6271, 1077, 570, 1078, 1208, 7188, 5584, 2674, 3109, 7435, 3111,
-6272, 573, 570, 1077, 1208, 4756, 7188, 7997, 7999, 7435, 3109,
-6273, 616, 570, 573, 1208, 4907, 4756, 4908, 5553, 7435, 7999,
-6274, 1259, 696, 594, 1258, 6290, 5149, 6401, 3345, 6341, 6346,
-6275, 496, 1081, 580, 1082, 6384, 6902, 4792, 6338, 2686, 8060,
-6276, 1283, 686, 1284, 1259, 7571, 6570, 3525, 3534, 6289, 3446,
-6277, 727, 739, 712, 1344, 5381, 5325, 5277, 7837, 6845, 7942,
-6278, 1221, 686, 1284, 631, 7060, 6570, 3442, 7151, 5141, 6569,
-6279, 330, 6, 782, 145, 3965, 6793, 5854, 5972, 3543, 1753,
-6280, 466, 487, 1138, 1036, 4473, 6412, 6413, 7352, 5506, 2863,
-6281, 551, 1146, 1145, 1202, 7735, 2889, 7849, 7736, 3087, 3086,
-6282, 317, 464, 1033, 489, 4395, 7691, 7327, 4481, 4482, 7329,
-6283, 829, 986, 262, 261, 2366, 7771, 7772, 8013, 6949, 3781,
-6284, 1132, 555, 1199, 1131, 5973, 7323, 3073, 2847, 8061, 3072,
-6285, 471, 1146, 551, 1147, 5630, 7735, 4681, 5631, 2892, 6115,
-6286, 955, 481, 373, 337, 5624, 4461, 5914, 5965, 4447, 4125,
-6287, 1372, 1356, 1364, 772, 1635, 1634, 1613, 6475, 6958, 6482,
-6288, 694, 1241, 1242, 625, 6105, 3287, 6104, 5169, 7618, 7523,
-6289, 917, 419, 273, 272, 7977, 4254, 7848, 6985, 4253, 3814,
-6290, 625, 1241, 1242, 1174, 7618, 3287, 7523, 7524, 3281, 3284,
-6291, 347, 310, 1019, 864, 4057, 5641, 7552, 5793, 5642, 2462,
-6292, 699, 751, 1342, 753, 5358, 7302, 6541, 5365, 5367, 6828,
-6293, 690, 673, 591, 1248, 5155, 5096, 5156, 7761, 8025, 6975,
-6294, 777, 1338, 1329, 1359, 6492, 1676, 7288, 6493, 1667, 1677,
-6295, 756, 732, 1330, 1345, 5378, 6499, 7938, 7934, 7935, 1682,
-6296, 1262, 673, 1310, 1248, 6277, 6714, 3515, 3513, 8025, 3514,
-6297, 769, 1348, 771, 750, 7672, 7673, 5436, 5430, 6614, 5435,
-6298, 1044, 470, 471, 1146, 7147, 4483, 6176, 2887, 8062, 5630,
-6299, 1353, 725, 750, 1324, 7633, 5352, 6613, 1697, 6634, 7904,
-6300, 1307, 684, 605, 677, 7732, 5131, 6770, 7253, 5134, 5108,
-6301, 1145, 470, 1044, 1146, 6431, 7147, 2885, 2889, 8062, 2887,
-6302, 1339, 744, 1363, 751, 6912, 7743, 1663, 6913, 5399, 7744,
-6303, 163, 800, 21, 801, 1807, 7204, 3576, 1809, 1811, 7301,
-6304, 371, 794, 950, 795, 7247, 2261, 6890, 6286, 1793, 2262,
-6305, 1309, 696, 732, 729, 6340, 5296, 6500, 6497, 5305, 5304,
-6306, 837, 278, 424, 920, 7872, 4269, 6332, 2175, 5894, 5626,
-6307, 560, 1203, 1293, 597, 6803, 3458, 6309, 4845, 7786, 6310,
-6308, 304, 102, 138, 137, 3905, 3663, 7694, 7972, 3662, 1491,
-6309, 471, 470, 551, 1146, 4483, 4682, 4681, 5630, 8062, 7735,
-6310, 551, 470, 1145, 1146, 4682, 6431, 7849, 7735, 8062, 2889,
-6311, 659, 647, 660, 1285, 5063, 5066, 5139, 7511, 5538, 7723,
-6312, 757, 1347, 1362, 728, 6556, 1670, 6933, 5384, 7286, 6107,
-6313, 648, 1296, 559, 614, 7505, 6867, 5007, 5008, 6471, 4899,
-6314, 535, 1157, 1155, 633, 5655, 2996, 5654, 4955, 6799, 7742,
-6315, 1220, 678, 1240, 1237, 6368, 6287, 3277, 3255, 5570, 3279,
-6316, 1240, 678, 679, 1237, 6287, 5116, 7309, 3279, 5570, 7310,
-6317, 1172, 1237, 1250, 642, 3324, 3323, 3317, 6254, 5572, 5728,
-6318, 1325, 718, 1291, 1279, 6735, 7560, 3495, 3429, 7004, 3454,
-6319, 1063, 1157, 534, 995, 2945, 8063, 7349, 2608, 2923, 7482,
-6320, 534, 1157, 1098, 995, 8063, 2924, 6502, 7482, 2923, 2745,
-6321, 535, 632, 534, 1157, 4953, 4952, 4633, 5655, 6183, 8063,
-6322, 534, 632, 1098, 1157, 4952, 6503, 6502, 8063, 6183, 2924,
-6323, 1158, 495, 387, 386, 6573, 4763, 7591, 7592, 4793, 4159,
-6324, 557, 556, 605, 1201, 4789, 4871, 4870, 6633, 6534, 6532,
-6325, 21, 800, 163, 162, 7204, 1807, 3576, 3577, 1806, 1398,
-6326, 1165, 1183, 601, 1184, 3034, 5681, 6076, 3174, 3100, 5680,
-6327, 240, 387, 386, 997, 4157, 4159, 4155, 6836, 7593, 7044,
-6328, 1295, 1336, 1325, 719, 3129, 3271, 3274, 7455, 7144, 6736,
-6329, 780, 1359, 768, 777, 6406, 6263, 5493, 5488, 6493, 5492,
-6330, 1299, 1248, 1310, 690, 3475, 3514, 3155, 7680, 7761, 8042,
-6331, 1210, 607, 610, 598, 5995, 4891, 7196, 6388, 4881, 4889,
-6332, 1063, 1157, 535, 534, 2945, 5655, 5910, 7349, 8063, 4633,
-6333, 1351, 776, 1365, 1338, 7312, 7094, 1648, 1668, 7095, 1666,
-6334, 735, 1336, 1295, 719, 7457, 3129, 7454, 5402, 7144, 7455,
-6335, 1099, 542, 639, 1168, 7275, 4974, 6041, 2989, 6516, 6519,
-6336, 1244, 1248, 1299, 690, 3312, 3475, 3474, 7681, 7761, 7680,
-6337, 1068, 542, 1006, 1168, 6223, 6225, 2625, 2962, 6516, 2963,
-6338, 504, 503, 1222, 620, 4536, 6169, 6587, 4919, 4811, 7706,
-6339, 558, 1205, 474, 1152, 7443, 7764, 4697, 7220, 3096, 6597,
-6340, 474, 1205, 1153, 1152, 7764, 3097, 7763, 6597, 3096, 2910,
-6341, 1222, 502, 1188, 620, 6073, 6074, 3288, 7706, 4810, 7587,
-6342, 781, 222, 1374, 77, 2070, 7558, 7704, 6045, 6162, 7653,
-6343, 301, 99, 133, 933, 3896, 3655, 7222, 7851, 6887, 2142,
-6344, 77, 76, 221, 838, 1600, 6859, 7186, 7118, 6824, 1902,
-6345, 1006, 542, 1099, 1168, 6225, 7275, 2746, 2963, 6516, 2989,
-6346, 753, 1333, 1342, 740, 8059, 1695, 6828, 5366, 8000, 6829,
-6347, 33, 177, 815, 178, 3604, 1851, 5749, 3603, 1413, 1852,
-6348, 188, 866, 43, 189, 1967, 5587, 5778, 1425, 1968, 8064,
-6349, 43, 866, 44, 189, 5587, 5588, 1567, 8064, 1968, 7875,
-6350, 669, 1214, 583, 653, 6050, 6218, 5085, 5086, 5830, 5037,
-6351, 492, 1128, 381, 566, 7827, 7263, 4504, 4730, 7638, 4728,
-6352, 459, 1126, 370, 567, 7319, 7648, 4380, 4731, 7318, 4732,
-6353, 647, 555, 1230, 564, 4999, 7324, 6560, 5040, 4719, 6966,
-6354, 44, 246, 43, 189, 3732, 3731, 1567, 7875, 7659, 8064,
-6355, 714, 1271, 1287, 1286, 7240, 3438, 7667, 7843, 3437, 3439,
-6356, 43, 246, 188, 189, 3731, 7658, 5778, 8064, 7659, 1425,
-6357, 639, 1246, 1186, 708, 6040, 3299, 6517, 5210, 6072, 6070,
-6358, 670, 1292, 1304, 665, 6056, 3491, 7128, 5121, 7790, 6926,
-6359, 712, 654, 727, 1314, 5218, 5275, 5277, 7894, 7807, 7806,
-6360, 1362, 1347, 1341, 728, 1670, 1690, 1691, 6107, 7286, 8043,
-6361, 540, 1170, 1166, 637, 7126, 2977, 5704, 4968, 5880, 5878,
-6362, 386, 1072, 239, 818, 7602, 7405, 4154, 7043, 2639, 7342,
-6363, 1174, 1223, 513, 625, 3191, 5543, 7472, 7524, 7619, 4932,
-6364, 1251, 1238, 692, 755, 3321, 8021, 7419, 6943, 6944, 5373,
-6365, 692, 1238, 693, 755, 8021, 6862, 5262, 5373, 6944, 5374,
-6366, 450, 306, 1011, 855, 4348, 7103, 7101, 8047, 6430, 2436,
-6367, 693, 743, 755, 1238, 5330, 5377, 5374, 6862, 7896, 6944,
-6368, 638, 708, 637, 1246, 5208, 5207, 4972, 5864, 6072, 5879,
-6369, 479, 372, 1083, 496, 4499, 7416, 7415, 4512, 4724, 6339,
-6370, 623, 1179, 622, 509, 8037, 7345, 4927, 4925, 7534, 4820,
-6371, 708, 1246, 748, 707, 6072, 7685, 5347, 5209, 6113, 5346,
-6372, 623, 1238, 692, 1179, 6847, 8021, 5163, 8037, 3273, 8065,
-6373, 1175, 585, 603, 1207, 7225, 4901, 6219, 3107, 5906, 6220,
-6374, 1288, 1293, 1263, 597, 3526, 3459, 1745, 6745, 6310, 7785,
-6375, 372, 1083, 549, 1084, 7416, 6337, 4678, 7417, 2695, 7437,
-6376, 1249, 643, 1165, 1169, 7361, 6075, 3315, 3316, 6258, 2967,
-6377, 1009, 1070, 547, 447, 2651, 5731, 5732, 5724, 5726, 4671,
-6378, 736, 1355, 1326, 1346, 6512, 1706, 5979, 6920, 1604, 1717,
-6379, 438, 293, 847, 437, 4311, 7381, 7380, 4313, 4309, 6838,
-6380, 439, 295, 440, 1003, 4315, 4317, 4319, 6941, 7914, 7498,
-6381, 847, 928, 1000, 437, 2224, 2407, 2406, 6838, 7178, 6837,
-6382, 934, 1069, 446, 852, 2630, 7371, 7226, 2187, 2631, 7779,
-6383, 910, 257, 55, 200, 5975, 3765, 6764, 2093, 5984, 7841,
-6384, 87, 119, 88, 289, 3629, 3630, 1537, 3860, 7162, 3861,
-6385, 56, 201, 910, 200, 6331, 2092, 6329, 7842, 1437, 2093,
-6386, 56, 910, 55, 200, 6329, 6764, 1579, 7842, 2093, 7841,
-6387, 66, 888, 210, 65, 5821, 2033, 7854, 1589, 7450, 6795,
-6388, 66, 65, 210, 915, 1589, 6795, 7854, 6334, 6796, 2103,
-6389, 692, 1238, 1251, 1179, 8021, 3321, 7419, 8065, 3273, 3319,
-6390, 848, 929, 294, 125, 2210, 6937, 7370, 1924, 2134, 6939,
-6391, 623, 1179, 692, 622, 8037, 8065, 5163, 4927, 7345, 5162,
-6392, 1243, 1258, 593, 1260, 3343, 7521, 6637, 3364, 3387, 7522,
-6393, 1273, 1327, 1318, 752, 3170, 1730, 3171, 6901, 7206, 7898,
-6394, 567, 566, 1227, 652, 4733, 6708, 5608, 5027, 5026, 6702,
-6395, 346, 862, 1018, 863, 7510, 2458, 7254, 7255, 1960, 2459,
-6396, 77, 1374, 2, 816, 7653, 6604, 1601, 6120, 7559, 6140,
-6397, 241, 39, 242, 819, 3717, 3719, 3721, 6149, 7146, 7145,
-6398, 892, 69, 215, 70, 8007, 8041, 2046, 7037, 1593, 7068,
-6399, 361, 69, 892, 70, 4035, 8007, 7011, 4034, 1593, 7037,
-6400, 891, 214, 892, 69, 2043, 2045, 2047, 7920, 7079, 8007,
-6401, 1309, 723, 686, 696, 6391, 5257, 6343, 6340, 5281, 5280,
-6402, 1263, 585, 666, 597, 6358, 5099, 6359, 7785, 4846, 5100,
-6403, 757, 731, 1337, 1347, 5382, 7466, 6555, 6556, 7284, 1701,
-6404, 1219, 630, 1221, 524, 6402, 6730, 3181, 7153, 4946, 7152,
-6405, 45, 189, 44, 867, 7874, 7875, 1568, 6398, 1970, 6397,
-6406, 815, 971, 329, 816, 2324, 6977, 6122, 1857, 2325, 6119,
-6407, 1362, 728, 1341, 733, 6107, 8043, 1691, 6106, 5302, 7548,
-6408, 1337, 711, 739, 1344, 7647, 5324, 6844, 1731, 8045, 6845,
-6409, 524, 523, 1219, 630, 4600, 7702, 7153, 4946, 4945, 6402,
-6410, 692, 1179, 1251, 622, 8065, 3319, 7419, 5162, 7345, 7420,
-6411, 11, 226, 12, 151, 3681, 3680, 1504, 3554, 7996, 3557,
-6412, 42, 821, 43, 245, 7210, 8036, 1566, 3728, 7769, 3729,
-6413, 1029, 873, 315, 1028, 2491, 7781, 5996, 2493, 2489, 5998,
-6414, 463, 1031, 316, 1030, 5796, 8004, 4393, 5797, 2499, 5806,
-6415, 524, 630, 1221, 631, 4946, 6730, 7152, 4948, 5034, 7151,
-6416, 1253, 1251, 691, 741, 3329, 7418, 7599, 7600, 7598, 5350,
-6417, 1297, 1251, 1253, 741, 3466, 3329, 3467, 6596, 7598, 7600,
-6418, 2, 1374, 4, 816, 6604, 6602, 3540, 6140, 7559, 1855,
-6419, 716, 662, 718, 1278, 5236, 5238, 5237, 7002, 7728, 7001,
-6420, 1084, 1212, 549, 577, 3132, 6717, 7437, 7793, 6718, 4774,
-6421, 1221, 631, 1284, 1190, 7151, 6569, 3442, 3182, 6054, 3441,
-6422, 1337, 731, 1287, 1347, 7466, 6930, 2653, 1701, 7284, 2654,
-6423, 713, 1345, 671, 732, 7018, 7016, 5299, 5300, 7935, 5295,
-6424, 1030, 875, 316, 874, 2495, 6876, 5806, 2494, 1996, 6873,
-6425, 1133, 1032, 463, 1031, 2849, 5946, 5945, 2848, 2502, 5796,
-6426, 987, 411, 518, 1160, 7969, 4580, 5827, 2935, 7739, 5828,
-6427, 409, 408, 986, 1060, 4225, 6948, 8015, 5814, 5813, 2595,
-6428, 911, 260, 1057, 986, 5551, 7993, 2581, 2367, 6807, 2583,
-6429, 1057, 260, 407, 986, 7993, 4217, 7413, 2583, 6807, 6947,
-6430, 1244, 674, 628, 690, 7679, 5097, 6141, 7681, 5160, 5159,
-6431, 625, 1241, 680, 695, 7618, 6701, 5119, 5267, 6840, 5260,
-6432, 1362, 764, 757, 728, 6108, 5411, 6933, 6107, 5410, 5384,
-6433, 671, 740, 1277, 713, 5221, 7408, 5560, 5299, 5359, 7017,
-6434, 1284, 631, 595, 1190, 6569, 4838, 7883, 3441, 6054, 6053,
-6435, 962, 807, 340, 233, 2298, 7677, 7759, 7812, 8022, 4053,
-6436, 413, 989, 914, 832, 7402, 2373, 5546, 5547, 2376, 2201,
-6437, 471, 360, 1046, 491, 4414, 6643, 7758, 4490, 4489, 7756,
-6438, 1185, 519, 1109, 1160, 7427, 6524, 3025, 3026, 6134, 2936,
-6439, 168, 233, 26, 806, 8066, 3694, 3588, 1824, 7813, 6132,
-6440, 25, 233, 26, 168, 3695, 3694, 1518, 3585, 8066, 3588,
-6441, 944, 943, 383, 1076, 2245, 5702, 5701, 2667, 2666, 5904,
-6442, 12, 790, 152, 789, 7795, 1776, 3556, 7796, 1778, 1774,
-6443, 749, 1300, 1251, 755, 7629, 3479, 7497, 5375, 6813, 6943,
-6444, 1262, 673, 1248, 1224, 6277, 8025, 3513, 3501, 6316, 3311,
-6445, 392, 973, 391, 245, 7453, 7391, 4174, 4172, 7770, 4170,
-6446, 1276, 1176, 1211, 607, 3402, 3123, 3403, 5994, 8035, 6198,
-6447, 1020, 347, 865, 311, 6087, 5791, 2465, 6088, 4102, 7292,
-6448, 1318, 773, 765, 761, 7897, 5455, 7588, 6297, 5444, 5417,
-6449, 1309, 696, 686, 1259, 6340, 5280, 6343, 3510, 6290, 6289,
-6450, 752, 773, 1318, 761, 5443, 7897, 7898, 5423, 5444, 6297,
-6451, 1354, 1336, 770, 1360, 1704, 7814, 6364, 1650, 1705, 6366,
-6452, 698, 721, 1313, 684, 5249, 6552, 6581, 5284, 5332, 7731,
-6453, 716, 1279, 1177, 1278, 7003, 3415, 7909, 7002, 3443, 3410,
-6454, 698, 684, 1307, 677, 5284, 7732, 5775, 5274, 5134, 7253,
-6455, 1082, 1177, 549, 1083, 3127, 7436, 6336, 2692, 3001, 6337,
-6456, 168, 233, 806, 805, 8066, 7813, 1824, 1822, 7952, 1826,
-6457, 1176, 1081, 1211, 580, 3000, 3121, 3123, 7603, 6902, 8057,
-6458, 716, 718, 1325, 1279, 5237, 6735, 6734, 7003, 7004, 3429,
-6459, 369, 948, 947, 1080, 6438, 2257, 6792, 7928, 2679, 2678,
-6460, 580, 1081, 1211, 1082, 6902, 3121, 8057, 8060, 2686, 3122,
-6461, 1286, 619, 714, 1271, 6946, 5222, 7843, 3437, 6950, 7240,
-6462, 665, 1292, 1271, 586, 7790, 3482, 6697, 5078, 6686, 6685,
-6463, 152, 151, 12, 789, 1387, 3557, 3556, 1774, 1773, 7796,
-6464, 1250, 1256, 679, 1237, 3338, 6853, 6854, 3323, 3339, 7310,
-6465, 703, 1346, 736, 762, 7700, 6920, 5316, 5409, 6921, 5418,
-6466, 961, 805, 806, 233, 2294, 1826, 2295, 7811, 7952, 7813,
-6467, 1227, 1292, 1197, 586, 3456, 3455, 3069, 5610, 6686, 5657,
-6468, 1174, 1181, 1242, 590, 3015, 3285, 3284, 6457, 5577, 7481,
-6469, 1291, 762, 730, 718, 6445, 5405, 8050, 7560, 5404, 5290,
-6470, 1253, 1289, 689, 688, 3457, 7365, 7123, 7376, 7377, 5179,
-6471, 1361, 753, 766, 1333, 7737, 5422, 7833, 1694, 8059, 7049,
-6472, 369, 1081, 580, 476, 6437, 6902, 4791, 4428, 5770, 4790,
-6473, 496, 1081, 949, 476, 6384, 2682, 6383, 4771, 5770, 5769,
-6474, 1241, 1311, 1308, 695, 3518, 3524, 3509, 6840, 5687, 5685,
-6475, 734, 1294, 1252, 1270, 6320, 3460, 6246, 6247, 3535, 3383,
-6476, 29, 173, 172, 810, 3594, 1408, 3595, 7053, 1837, 1836,
-6477, 1242, 1312, 683, 1238, 3527, 7753, 7859, 3286, 3528, 6863,
-6478, 286, 115, 85, 843, 7703, 3623, 3852, 5882, 1914, 7693,
-6479, 226, 333, 945, 368, 4046, 7967, 8019, 4116, 4115, 5744,
-6480, 170, 807, 340, 808, 1828, 7677, 7987, 1830, 1832, 6776,
-6481, 843, 995, 1063, 431, 2391, 2608, 2607, 7071, 7486, 5912,
-6482, 953, 952, 372, 1084, 2272, 6740, 7117, 2694, 2693, 7417,
-6483, 730, 1335, 1346, 1328, 6563, 1715, 7701, 6564, 1617, 1725,
-6484, 484, 809, 965, 810, 6318, 2306, 7005, 7108, 1838, 2307,
-6485, 924, 995, 430, 998, 2392, 7485, 5884, 2402, 2606, 7487,
-6486, 77, 5, 2, 1374, 3673, 1497, 1601, 7653, 7515, 6604,
-6487, 804, 960, 339, 805, 2291, 5494, 5615, 1823, 2292, 5496,
-6488, 1342, 753, 1361, 1333, 6828, 7737, 1661, 1695, 8059, 1694,
-6489, 903, 42, 187, 41, 6655, 7209, 2078, 5752, 1565, 7625,
-6490, 187, 186, 903, 41, 1423, 2079, 2078, 7625, 5751, 5752,
-6491, 975, 973, 391, 1114, 2336, 7391, 7957, 2790, 2789, 5862,
-6492, 214, 917, 215, 69, 2107, 2106, 1451, 7079, 6986, 8041,
-6493, 1163, 1114, 975, 390, 2946, 2790, 2947, 6033, 7628, 6085,
-6494, 601, 1249, 1165, 1184, 7360, 3315, 6076, 5680, 3337, 3174,
-6495, 464, 1135, 1134, 552, 7692, 2856, 6535, 4683, 7787, 6536,
-6496, 735, 729, 1330, 732, 5315, 6498, 7982, 5314, 5304, 6499,
-6497, 1143, 1201, 1142, 557, 3085, 3084, 2880, 6886, 6633, 6883,
-6498, 1240, 710, 679, 678, 6288, 5356, 7309, 6287, 5298, 5116,
-6499, 646, 1225, 578, 644, 6627, 6081, 4998, 5022, 6083, 4994,
-6500, 1264, 1226, 617, 1257, 2985, 6808, 7227, 2984, 2986, 6629,
-6501, 1233, 1201, 1143, 557, 3238, 3085, 3236, 6632, 6633, 6886,
-6502, 1142, 556, 557, 1201, 7494, 4789, 6883, 3084, 6534, 6633,
-6503, 1319, 1356, 742, 1358, 1710, 6957, 6466, 1711, 1671, 6467,
-6504, 1309, 696, 671, 732, 6340, 5251, 6292, 6500, 5296, 5295,
-6505, 240, 37, 901, 818, 3713, 8067, 6834, 6835, 8029, 2114,
-6506, 308, 345, 859, 36, 4103, 8028, 5801, 3917, 4001, 7567,
-6507, 1132, 1230, 1199, 555, 3074, 3076, 3073, 5973, 7324, 7323,
-6508, 1016, 861, 344, 860, 2453, 6531, 5835, 2452, 1954, 6468,
-6509, 237, 817, 856, 179, 5824, 2153, 6580, 5823, 1860, 2069,
-6510, 209, 208, 914, 63, 1445, 2101, 2100, 7721, 7722, 5583,
-6511, 1055, 413, 989, 1109, 5858, 7402, 2574, 2772, 7724, 2770,
-6512, 671, 1258, 593, 696, 6269, 7521, 5092, 5251, 6341, 5148,
-6513, 975, 1114, 391, 390, 2790, 5862, 7957, 6085, 7628, 4171,
-6514, 1377, 62, 264, 265, 7573, 3786, 6709, 6710, 3788, 3790,
-6515, 1133, 564, 1134, 1230, 6965, 7637, 2853, 3075, 6966, 3223,
-6516, 371, 949, 950, 794, 6889, 2263, 6890, 7247, 2259, 2261,
-6517, 988, 412, 265, 411, 6893, 4232, 6897, 6892, 4234, 4230,
-6518, 369, 334, 792, 948, 4117, 7083, 6791, 6438, 6386, 2255,
-6519, 1309, 1258, 671, 696, 3511, 6269, 6292, 6340, 6341, 5251,
-6520, 730, 1328, 1346, 1291, 6564, 1725, 7701, 8050, 2736, 2688,
-6521, 897, 219, 75, 327, 2060, 7119, 5843, 7306, 7304, 3954,
-6522, 215, 917, 70, 69, 2106, 7067, 7068, 8041, 6986, 1593,
-6523, 559, 1201, 648, 556, 6021, 6533, 5007, 4703, 6534, 5006,
-6524, 1209, 570, 1079, 598, 7434, 8005, 3116, 6390, 4879, 6389,
-6525, 746, 706, 747, 1236, 5341, 5343, 5342, 5557, 5755, 5556,
-6526, 381, 1026, 1128, 1027, 7200, 2833, 7263, 7199, 2487, 2834,
-6527, 483, 961, 962, 233, 7396, 2299, 7398, 4452, 7811, 7812,
-6528, 936, 304, 305, 103, 7705, 3910, 7189, 7980, 3906, 3908,
-6529, 351, 872, 195, 194, 6590, 1986, 6624, 7632, 1985, 1431,
-6530, 676, 1279, 1280, 1212, 6508, 3428, 6351, 6350, 3416, 3417,
-6531, 705, 706, 746, 1236, 5201, 5341, 5309, 5757, 5755, 5557,
-6532, 581, 1279, 676, 1212, 5512, 6508, 5110, 5511, 3416, 6350,
-6533, 97, 130, 131, 932, 3650, 1484, 3651, 7755, 2141, 2140,
-6534, 308, 36, 859, 37, 3917, 7567, 5801, 3916, 1560, 5802,
-6535, 479, 951, 952, 796, 7295, 2269, 7335, 7607, 2265, 2267,
-6536, 1221, 686, 631, 630, 7060, 5141, 7151, 6730, 5140, 5034,
-6537, 479, 952, 229, 796, 7335, 6741, 4442, 7607, 2267, 7918,
-6538, 7, 783, 330, 224, 6758, 5971, 3964, 3677, 6988, 3992,
-6539, 375, 482, 494, 959, 4465, 4508, 4743, 5523, 6165, 5531,
-6540, 26, 807, 170, 169, 6139, 1828, 3589, 3587, 1827, 1405,
-6541, 340, 807, 170, 26, 7677, 1828, 7987, 3986, 6139, 3589,
-6542, 611, 1212, 581, 676, 6382, 5511, 4893, 5106, 6350, 5110,
-6543, 901, 37, 182, 818, 8067, 6423, 2075, 2114, 8029, 1861,
-6544, 35, 900, 817, 180, 6188, 2154, 5825, 6180, 2073, 1859,
-6545, 320, 356, 467, 1038, 4090, 4404, 4403, 7910, 7913, 7547,
-6546, 34, 857, 307, 35, 6051, 5521, 3915, 1558, 6052, 3914,
-6547, 320, 882, 356, 1038, 7138, 7298, 4090, 7910, 2518, 7913,
-6548, 626, 514, 1187, 1223, 4824, 5933, 7891, 7666, 6150, 3257,
-6549, 680, 1241, 625, 1223, 6701, 7618, 5119, 6255, 3280, 7619,
-6550, 844, 288, 433, 926, 7563, 4296, 7474, 2179, 7877, 5817,
-6551, 829, 262, 1373, 59, 7772, 7424, 7878, 7887, 3779, 6927,
-6552, 121, 927, 291, 290, 2129, 7029, 7027, 6858, 6455, 3868,
-6553, 261, 59, 262, 829, 3777, 3779, 3781, 8013, 7887, 7772,
-6554, 505, 589, 1193, 621, 4817, 7208, 6091, 4816, 4815, 6092,
-6555, 1334, 743, 702, 1312, 6974, 5364, 6003, 3378, 7509, 6004,
-6556, 793, 948, 476, 949, 2256, 5771, 6387, 2258, 2260, 5769,
-6557, 426, 281, 282, 840, 4275, 3841, 4276, 8039, 5696, 7166,
-6558, 1252, 734, 1255, 1294, 6246, 7379, 3336, 3460, 6320, 3461,
-6559, 999, 281, 426, 840, 5694, 4275, 7290, 2403, 5696, 8039,
-6560, 426, 840, 282, 972, 8039, 7166, 4276, 7170, 2329, 7746,
-6561, 626, 680, 625, 1223, 5120, 5119, 5042, 7666, 6255, 7619,
-6562, 924, 84, 286, 115, 6956, 3851, 5883, 2123, 3622, 7703,
-6563, 1154, 972, 569, 1161, 2915, 7171, 5789, 2938, 2937, 6238,
-6564, 427, 569, 426, 972, 4739, 4738, 4280, 6579, 7171, 7170,
-6565, 7, 783, 224, 146, 6758, 6988, 3677, 3545, 1756, 7823,
-6566, 514, 1223, 626, 513, 6150, 7666, 4824, 4568, 5543, 4823,
-6567, 1144, 557, 1143, 486, 7403, 6886, 2883, 7354, 4696, 7960,
-6568, 1202, 618, 1272, 1234, 8034, 6904, 3389, 3262, 7660, 3388,
-6569, 1221, 631, 526, 525, 7151, 4835, 7983, 7150, 4834, 4607,
-6570, 98, 131, 132, 851, 3652, 1485, 3653, 7949, 1930, 1929,
-6571, 29, 810, 172, 341, 7053, 1836, 3595, 3987, 7122, 5652,
-6572, 1272, 618, 658, 1234, 6904, 5061, 5776, 3388, 7660, 6674,
-6573, 658, 576, 602, 1234, 5059, 4861, 5060, 6674, 5600, 7853,
-6574, 346, 863, 40, 862, 7255, 7268, 4004, 7510, 1960, 8068,
-6575, 40, 863, 185, 862, 7268, 1958, 5900, 8068, 1960, 1956,
-6576, 1307, 602, 658, 677, 7447, 5060, 5774, 7253, 5107, 5109,
-6577, 184, 39, 185, 862, 7514, 8055, 1421, 1955, 6158, 1956,
-6578, 903, 244, 973, 245, 6213, 6214, 2331, 7768, 3730, 7770,
-6579, 185, 184, 902, 39, 1421, 2077, 2076, 8055, 7514, 7036,
-6580, 39, 346, 40, 862, 4005, 4004, 1563, 6158, 7510, 8068,
-6581, 1118, 1017, 1119, 380, 2804, 2806, 2808, 7860, 7096, 5954,
-6582, 241, 38, 39, 819, 3716, 1562, 3717, 6149, 5925, 7146,
-6583, 64, 322, 65, 887, 3945, 3944, 1588, 6192, 6191, 7449,
-6584, 195, 825, 51, 50, 1876, 7804, 7802, 6626, 7580, 1574,
-6585, 825, 252, 253, 50, 6720, 3754, 6719, 7580, 3750, 3752,
-6586, 1131, 555, 1199, 579, 8061, 7323, 3072, 6748, 4786, 6747,
-6587, 1023, 1124, 457, 1125, 2822, 8002, 5697, 2824, 2826, 6276,
-6588, 253, 51, 825, 50, 3753, 7804, 6719, 3752, 1574, 7580,
-6589, 185, 39, 40, 862, 8055, 1563, 5900, 1956, 6158, 8068,
-6590, 600, 1301, 1261, 1303, 7869, 3512, 7639, 7943, 3489, 3516,
-6591, 195, 50, 51, 873, 6626, 1574, 7802, 1988, 6625, 7829,
-6592, 496, 949, 371, 476, 6383, 6889, 4513, 4771, 5769, 4429,
-6593, 811, 173, 29, 810, 1839, 3594, 7052, 1841, 1837, 7053,
-6594, 262, 60, 263, 830, 3780, 3782, 3784, 5913, 5688, 5691,
-6595, 1373, 262, 830, 60, 7424, 5913, 6374, 6732, 3780, 5688,
-6596, 264, 207, 913, 206, 7809, 2098, 6712, 6934, 1443, 2099,
-6597, 264, 61, 206, 263, 3785, 6680, 6934, 3787, 3783, 5690,
-6598, 352, 874, 51, 873, 7270, 7280, 4017, 7855, 1993, 7829,
-6599, 51, 315, 352, 873, 3930, 4062, 4017, 7829, 7781, 7855,
-6600, 657, 1268, 1303, 1302, 7941, 3490, 7940, 7752, 3485, 3531,
-6601, 1152, 1151, 558, 1204, 2907, 8038, 7220, 3094, 3093, 7699,
-6602, 526, 421, 1162, 420, 4606, 6063, 5721, 4605, 4261, 8032,
-6603, 661, 1303, 715, 657, 7045, 5867, 5227, 5069, 7940, 5226,
-6604, 661, 600, 1261, 1303, 5067, 7639, 6725, 7045, 7943, 3516,
-6605, 51, 50, 315, 873, 1574, 3931, 3930, 7829, 6625, 7781,
-6606, 195, 873, 51, 196, 1988, 7829, 7802, 1432, 1989, 7803,
-6607, 792, 334, 793, 948, 7083, 6385, 1787, 2255, 6386, 2256,
-6608, 468, 357, 1040, 321, 4406, 7395, 7411, 4405, 4091, 7412,
-6609, 62, 885, 207, 884, 7281, 2024, 7622, 7283, 2026, 2022,
-6610, 207, 884, 206, 61, 2022, 2021, 1443, 7888, 6651, 6680,
-6611, 901, 37, 240, 38, 8067, 3713, 6834, 6163, 1561, 3714,
-6612, 62, 884, 61, 357, 7283, 6651, 1585, 4026, 6652, 4027,
-6613, 62, 884, 207, 61, 7283, 2022, 7622, 1585, 6651, 7888,
-6614, 1363, 1366, 778, 1370, 1606, 7794, 7426, 1605, 1607, 6993,
-6615, 1277, 1333, 713, 740, 2698, 7048, 7017, 7408, 8000, 5359,
-6616, 545, 445, 1008, 444, 4665, 7173, 7583, 4664, 4334, 5768,
-6617, 604, 657, 614, 1268, 5055, 5057, 5005, 7871, 7941, 6470,
-6618, 397, 906, 980, 979, 6545, 2350, 6509, 6544, 2347, 2584,
-6619, 218, 895, 73, 896, 2055, 7862, 6097, 2057, 2059, 7322,
-6620, 217, 72, 218, 895, 5537, 7198, 1454, 2054, 6684, 2055,
-6621, 406, 514, 405, 1106, 4567, 4566, 4216, 6396, 5934, 6644,
-6622, 554, 1203, 560, 597, 7662, 6803, 4706, 4844, 7786, 4845,
-6623, 703, 721, 1355, 1331, 5248, 8053, 7780, 6942, 6554, 1603,
-6624, 73, 72, 326, 895, 1596, 3953, 3952, 7862, 6684, 6683,
-6625, 218, 72, 73, 895, 7198, 1596, 6097, 2055, 6684, 7862,
-6626, 466, 1036, 1138, 1037, 7352, 2863, 6413, 7236, 2517, 2864,
-6627, 756, 1357, 713, 1345, 6283, 7047, 5380, 7934, 1683, 7018,
-6628, 320, 882, 60, 356, 7138, 6733, 3941, 4090, 7298, 4024,
-6629, 25, 233, 168, 805, 3695, 8066, 3585, 7885, 7952, 1822,
-6630, 357, 883, 320, 1039, 6653, 6673, 4067, 7549, 2521, 7911,
-6631, 1043, 486, 1144, 1042, 6716, 7354, 2882, 2535, 7936, 2881,
-6632, 991, 270, 417, 271, 7132, 4247, 7621, 7217, 3808, 4248,
-6633, 251, 906, 250, 48, 7059, 7021, 3748, 3746, 7953, 3744,
-6634, 824, 906, 251, 48, 2193, 7059, 7008, 7009, 7953, 3746,
-6635, 1043, 359, 1044, 470, 7624, 6483, 2538, 6715, 4411, 7147,
-6636, 251, 906, 397, 250, 7059, 6545, 4188, 3748, 7021, 4187,
-6637, 980, 906, 397, 251, 2350, 6545, 6509, 7058, 7059, 4188,
-6638, 658, 602, 1307, 1234, 5060, 7447, 5774, 6674, 7853, 3507,
-6639, 282, 840, 922, 972, 7166, 2221, 7165, 7746, 2329, 2328,
-6640, 433, 288, 844, 432, 4296, 7563, 7474, 4298, 4294, 7473,
-6641, 155, 334, 792, 14, 6806, 7083, 1783, 3561, 3974, 8069,
-6642, 848, 294, 295, 93, 7370, 3880, 7464, 7465, 3876, 3878,
-6643, 155, 792, 154, 14, 1783, 1782, 1390, 3561, 8069, 3562,
-6644, 792, 334, 227, 14, 7083, 4047, 6790, 8069, 3974, 3682,
-6645, 439, 295, 848, 294, 4315, 7464, 7369, 4314, 3880, 7370,
-6646, 340, 808, 27, 170, 6776, 6323, 3985, 7987, 1830, 3591,
-6647, 440, 541, 439, 1003, 4652, 4651, 4319, 7498, 5707, 6941,
-6648, 273, 917, 272, 70, 7848, 6985, 3814, 3812, 7067, 3810,
-6649, 809, 234, 484, 808, 6319, 4454, 6318, 1835, 6324, 7141,
-6650, 548, 1183, 1009, 1071, 6802, 3033, 5664, 5665, 3050, 2636,
-6651, 1011, 1010, 450, 855, 2638, 6433, 7101, 2436, 2434, 8047,
-6652, 639, 1246, 1099, 1186, 6040, 3300, 6041, 6517, 3299, 3029,
-6653, 85, 116, 287, 843, 3624, 6959, 3854, 7693, 1913, 6960,
-6654, 1090, 571, 375, 1091, 7313, 4748, 5529, 2719, 7975, 8054,
-6655, 908, 254, 255, 52, 6878, 3760, 7730, 7274, 3756, 3758,
-6656, 462, 555, 1131, 579, 4691, 8061, 5782, 4784, 4786, 6748,
-6657, 152, 13, 153, 790, 3559, 3558, 1388, 1776, 5693, 1777,
-6658, 462, 555, 1132, 1131, 4691, 5973, 7496, 5782, 8061, 2847,
-6659, 908, 52, 255, 197, 7274, 3758, 7730, 2088, 7269, 6450,
-6660, 198, 53, 54, 876, 6451, 1577, 7714, 1997, 7715, 7713,
-6661, 792, 227, 154, 14, 6790, 7499, 1782, 8069, 3682, 3562,
-6662, 851, 299, 444, 300, 6896, 4329, 5767, 7951, 3895, 4330,
-6663, 925, 287, 288, 117, 5874, 3859, 7561, 2125, 7946, 7562,
-6664, 529, 424, 1097, 423, 4615, 5627, 5722, 4614, 4270, 5723,
-6665, 482, 803, 802, 958, 6164, 1817, 7317, 6001, 2286, 2285,
-6666, 232, 482, 803, 338, 4448, 6164, 5651, 4079, 4449, 6280,
-6667, 445, 301, 446, 852, 4333, 4335, 4337, 7948, 7223, 7779,
-6668, 482, 958, 802, 374, 6001, 2285, 7317, 4500, 6000, 6645,
-6669, 482, 374, 802, 338, 4500, 6645, 7317, 4449, 4127, 7105,
-6670, 460, 348, 1022, 312, 4383, 7905, 5633, 4382, 4101, 6090,
-6671, 1023, 1124, 460, 457, 2822, 5634, 5632, 5697, 8002, 4384,
-6672, 375, 960, 1090, 1091, 5524, 2715, 5529, 8054, 2717, 2719,
-6673, 131, 299, 932, 851, 8070, 5742, 2140, 1930, 6896, 2213,
-6674, 26, 233, 340, 807, 3694, 4053, 3986, 6139, 8022, 7677,
-6675, 182, 901, 38, 37, 2075, 6163, 6979, 6423, 8067, 1561,
-6676, 617, 498, 1264, 608, 4911, 6010, 7227, 4910, 4884, 6011,
-6677, 1264, 1292, 1315, 608, 3517, 3533, 3532, 6011, 6058, 6057,
-6678, 1250, 642, 1167, 1172, 5728, 5729, 3294, 3317, 6254, 2969,
-6679, 851, 300, 98, 299, 7951, 3893, 7949, 6896, 3895, 3891,
-6680, 350, 47, 870, 48, 4013, 6781, 6780, 4012, 1571, 6995,
-6681, 1024, 1126, 370, 1025, 2827, 7648, 6739, 2481, 2828, 7966,
-6682, 1221, 525, 1110, 524, 7150, 7357, 3180, 7152, 4603, 5936,
-6683, 131, 299, 97, 932, 8070, 3890, 3651, 2140, 5742, 7755,
-6684, 1317, 685, 1306, 1335, 6700, 6204, 3362, 3283, 6206, 3357,
-6685, 1110, 1103, 1219, 523, 2775, 3166, 3165, 6599, 6601, 7702,
-6686, 98, 299, 131, 851, 3891, 8070, 3652, 7949, 6896, 1930,
-6687, 92, 125, 929, 124, 3640, 2134, 6938, 3639, 1478, 2135,
-6688, 890, 212, 67, 889, 2039, 6801, 7243, 2041, 2037, 7237,
-6689, 182, 37, 38, 860, 6423, 1561, 6979, 1949, 5804, 6530,
-6690, 1107, 508, 509, 1102, 6017, 4551, 6971, 2927, 6991, 6989,
-6691, 131, 299, 98, 97, 8070, 3891, 3652, 3651, 3890, 1547,
-6692, 1307, 602, 1233, 1234, 7447, 7404, 3505, 3507, 7853, 3241,
-6693, 757, 731, 711, 1337, 5382, 5293, 5383, 6555, 7466, 7647,
-6694, 1073, 939, 478, 367, 2656, 7801, 7644, 7646, 6752, 4437,
-6695, 157, 156, 16, 794, 1392, 3566, 3565, 1789, 1788, 5960,
-6696, 435, 291, 846, 927, 4303, 7028, 7348, 6456, 7029, 2131,
-6697, 1287, 731, 714, 722, 6930, 5291, 7667, 7821, 5294, 5255,
-6698, 478, 939, 1073, 940, 7801, 2656, 7644, 5773, 2233, 2657,
-6699, 363, 1052, 474, 475, 5939, 6417, 4422, 4494, 5941, 4502,
-6700, 1075, 1207, 603, 575, 3105, 6220, 5929, 5892, 7078, 5004,
-6701, 627, 1224, 1262, 1245, 6315, 3501, 6243, 6245, 3298, 3354,
-6702, 1073, 1205, 1153, 497, 3098, 3097, 3044, 7645, 7766, 7765,
-6703, 943, 366, 1075, 942, 5888, 7963, 2664, 2242, 5887, 2663,
-6704, 550, 1139, 559, 467, 7421, 6929, 4702, 4679, 7906, 4701,
-6705, 626, 1223, 1187, 1245, 7666, 3257, 7891, 8071, 3318, 3297,
-6706, 1011, 1072, 385, 1158, 2800, 7582, 7541, 2929, 2928, 7596,
-6707, 1100, 1184, 1163, 500, 3024, 3023, 2961, 7517, 6843, 6023,
-6708, 474, 475, 1153, 497, 4502, 7615, 7763, 4515, 4514, 7765,
-6709, 188, 821, 43, 42, 1867, 8036, 5778, 5779, 7210, 1566,
-6710, 393, 392, 1056, 503, 4177, 7384, 7720, 4533, 4531, 7382,
-6711, 1265, 1273, 746, 752, 3393, 5558, 5852, 6394, 6901, 5362,
-6712, 1013, 454, 364, 328, 5851, 4441, 6060, 5849, 4434, 4098,
-6713, 1115, 475, 367, 497, 7616, 4518, 6753, 7799, 4514, 4726,
-6714, 1056, 503, 1222, 504, 7382, 6169, 3183, 6588, 4536, 6587,
-6715, 1140, 490, 559, 467, 6128, 4700, 6007, 7545, 4485, 4701,
-6716, 559, 1139, 1140, 467, 6929, 2871, 6007, 4701, 7906, 7545,
-6717, 1253, 688, 689, 588, 7376, 5179, 7123, 7125, 5178, 5153,
-6718, 660, 722, 1286, 687, 5253, 7844, 6068, 5145, 5254, 6069,
-6719, 59, 356, 60, 882, 4025, 4024, 1583, 6928, 7298, 6733,
-6720, 935, 1071, 448, 1009, 2635, 5666, 6123, 2430, 2636, 5663,
-6721, 580, 651, 496, 1082, 5045, 5020, 4792, 8060, 7538, 6338,
-6722, 627, 1223, 626, 1245, 6244, 7666, 4937, 6245, 3318, 8071,
-6723, 473, 554, 558, 1151, 4688, 4744, 4698, 7110, 7429, 8038,
-6724, 1229, 553, 600, 552, 7933, 4852, 7868, 8052, 4788, 4853,
-6725, 1295, 719, 1325, 1280, 7455, 6736, 3274, 3422, 8048, 3421,
-6726, 697, 719, 1295, 1280, 5242, 7455, 7456, 6356, 8048, 3422,
-6727, 595, 631, 1284, 664, 4838, 6569, 7883, 5076, 5075, 6571,
-6728, 1243, 521, 1111, 1182, 6638, 6822, 3290, 3359, 7148, 3019,
-6729, 627, 1245, 591, 1224, 6245, 7508, 5041, 6315, 3298, 6976,
-6730, 1111, 1103, 416, 522, 2780, 7115, 6167, 6156, 6157, 4593,
-6731, 1111, 414, 1055, 521, 6020, 5857, 2779, 6822, 4589, 7923,
-6732, 951, 1082, 496, 1083, 2687, 6338, 7296, 2690, 2692, 6339,
-6733, 1211, 651, 580, 1082, 6199, 5045, 8057, 3122, 7538, 8060,
-6734, 281, 79, 921, 280, 3836, 7749, 5695, 3838, 3835, 6636,
-6735, 305, 104, 306, 855, 3909, 3911, 3913, 7979, 6945, 6430,
-6736, 627, 1245, 516, 591, 6245, 7507, 4936, 5041, 7508, 4825,
-6737, 890, 68, 891, 360, 7428, 7919, 2044, 7246, 4032, 6642,
-6738, 436, 292, 437, 928, 4306, 4308, 4310, 7179, 7711, 7178,
-6739, 846, 436, 1000, 928, 7167, 7177, 2416, 2181, 7179, 2407,
-6740, 891, 68, 890, 213, 7919, 7428, 2044, 2042, 6270, 2040,
-6741, 710, 1289, 1240, 1256, 7279, 3450, 6288, 7277, 3449, 3349,
-6742, 121, 846, 122, 291, 1920, 1919, 1475, 7027, 7028, 7356,
-6743, 960, 1091, 375, 376, 2717, 8054, 5524, 5601, 7610, 4450,
-6744, 587, 663, 609, 1269, 5170, 5073, 4918, 6036, 6857, 6885,
-6745, 572, 1091, 571, 1215, 7974, 7975, 4794, 7570, 3147, 6841,
-6746, 821, 246, 43, 245, 7643, 3731, 8036, 7769, 3733, 3729,
-6747, 111, 922, 282, 110, 2119, 7165, 7155, 1464, 2120, 7164,
-6748, 111, 110, 282, 81, 1464, 7164, 7155, 3615, 3614, 3840,
-6749, 730, 1291, 1346, 762, 8050, 2688, 7701, 5405, 6445, 6921,
-6750, 1163, 1184, 1188, 501, 3023, 3173, 3036, 6032, 6660, 7631,
-6751, 592, 520, 1185, 519, 4828, 6361, 7657, 4827, 4587, 7427,
-6752, 448, 1071, 935, 854, 5666, 2635, 6123, 6124, 2634, 2216,
-6753, 698, 684, 1313, 1307, 5284, 7731, 6581, 5775, 7732, 1734,
-6754, 293, 91, 92, 124, 3872, 1541, 3873, 7789, 3638, 3639,
-6755, 510, 1181, 623, 1179, 6400, 6846, 4926, 5658, 3164, 8037,
-6756, 492, 566, 1198, 1128, 4730, 6703, 7882, 7827, 7638, 3070,
-6757, 1340, 763, 1329, 754, 5969, 6611, 1680, 7757, 5407, 7884,
-6758, 303, 304, 137, 102, 3907, 7972, 7695, 3903, 3905, 3662,
-6759, 516, 1245, 627, 515, 7507, 6245, 4936, 4574, 7489, 4935,
-6760, 656, 654, 1266, 720, 5054, 6251, 5785, 5245, 5247, 7362,
-6761, 626, 1245, 1187, 515, 8071, 3297, 7891, 4934, 7489, 7490,
-6762, 1109, 520, 412, 519, 6362, 4585, 6522, 6524, 4587, 4583,
-6763, 736, 1326, 759, 762, 5979, 5981, 5446, 5418, 6446, 5413,
-6764, 627, 1245, 626, 515, 6245, 8071, 4937, 4935, 7489, 4934,
-6765, 1256, 672, 688, 1254, 7612, 5151, 7605, 3447, 6849, 7375,
-6766, 403, 512, 402, 983, 4561, 4559, 4207, 6478, 7315, 7232,
-6767, 1086, 481, 562, 565, 5625, 4712, 6377, 6378, 4721, 4723,
-6768, 480, 1085, 954, 1084, 5622, 2699, 5605, 7792, 2701, 2696,
-6769, 957, 481, 562, 956, 7242, 4712, 6129, 2284, 5623, 6917,
-6770, 374, 481, 562, 957, 4495, 4712, 4711, 6646, 7242, 6129,
-6771, 1085, 565, 611, 577, 6380, 4894, 6381, 7810, 4787, 4892,
-6772, 438, 1004, 847, 929, 6953, 2418, 7380, 7366, 2417, 2182,
-6773, 50, 49, 194, 907, 1573, 7325, 7330, 7331, 7326, 2087,
-6774, 449, 1071, 448, 854, 5809, 5666, 4346, 6618, 2634, 6124,
-6775, 1198, 566, 492, 619, 6703, 4730, 7882, 6704, 4915, 4914,
-6776, 461, 1027, 381, 1128, 6568, 7199, 4387, 6620, 2834, 7263,
-6777, 826, 1059, 909, 402, 2590, 2592, 2164, 7248, 7231, 7230,
-6778, 10, 332, 11, 150, 3969, 3968, 1503, 3552, 8027, 3555,
-6779, 193, 871, 870, 48, 1982, 1984, 1980, 6585, 6586, 6995,
-6780, 582, 458, 1122, 455, 4798, 6301, 7838, 4854, 4377, 6662,
-6781, 824, 48, 194, 193, 7009, 6584, 1873, 1874, 6585, 1430,
-6782, 303, 136, 935, 853, 7696, 2147, 7697, 7991, 1933, 2188,
-6783, 1310, 673, 701, 699, 6714, 5188, 7955, 6540, 5180, 5244,
-6784, 691, 1251, 749, 741, 7418, 7497, 5348, 5350, 7598, 5351,
-6785, 518, 519, 1160, 411, 4584, 6134, 5828, 4580, 4582, 7739,
-6786, 1022, 348, 460, 455, 7905, 4383, 5633, 5747, 4365, 4459,
-6787, 984, 827, 403, 404, 2361, 6557, 6476, 5499, 5977, 4210,
-6788, 591, 673, 627, 1224, 5096, 5095, 5041, 6976, 6316, 6315,
-6789, 1002, 1065, 1066, 434, 2781, 2650, 2619, 8024, 6422, 7341,
-6790, 1308, 701, 680, 695, 6274, 5187, 6272, 5685, 5261, 5260,
-6791, 680, 1241, 1308, 695, 6701, 3509, 6272, 5260, 6840, 5685,
-6792, 276, 1062, 919, 994, 7931, 2605, 6026, 7912, 2649, 2389,
-6793, 778, 744, 1363, 1372, 5469, 7743, 7426, 6994, 7830, 1630,
-6794, 657, 600, 661, 1303, 5056, 5067, 5069, 7940, 7943, 7045,
-6795, 150, 332, 788, 787, 8027, 6031, 1770, 1768, 7984, 1772,
-6796, 1219, 1103, 522, 523, 3166, 6157, 6239, 7702, 6601, 4597,
-6797, 572, 1091, 1092, 376, 7974, 2722, 7555, 4752, 7610, 7609,
-6798, 276, 994, 423, 422, 7912, 6689, 4265, 4263, 6687, 4267,
-6799, 1256, 700, 688, 672, 7276, 5183, 7605, 7612, 5182, 5151,
-6800, 1067, 443, 544, 444, 8026, 4661, 7778, 7777, 4331, 4662,
-6801, 1062, 994, 276, 422, 2649, 7912, 7931, 6065, 6687, 4263,
-6802, 1062, 422, 1162, 1159, 6065, 6066, 2940, 2933, 6688, 2971,
-6803, 150, 332, 11, 788, 8027, 3968, 3555, 1770, 6031, 7668,
-6804, 1218, 1162, 527, 1159, 3177, 6307, 6494, 3185, 2971, 6923,
-6805, 1002, 1064, 432, 844, 2614, 5839, 5837, 2413, 2611, 7473,
-6806, 1002, 536, 1155, 1065, 5838, 6354, 2919, 2781, 7476, 2918,
-6807, 527, 422, 528, 1159, 4609, 4611, 4613, 6923, 6688, 5708,
-6808, 307, 1005, 280, 365, 5520, 6352, 4000, 4106, 5899, 4107,
-6809, 561, 1147, 551, 1202, 6114, 6115, 4709, 6825, 3088, 7736,
-6810, 88, 845, 120, 290, 7161, 1917, 3631, 3863, 6737, 6833,
-6811, 846, 1054, 1000, 436, 2568, 2570, 2416, 7167, 7347, 7177,
-6812, 846, 928, 122, 292, 2181, 2133, 1919, 7168, 7711, 7355,
-6813, 1165, 547, 548, 1009, 5730, 4675, 6193, 2951, 5732, 5664,
-6814, 426, 281, 999, 365, 4275, 5694, 7290, 4277, 4108, 5898,
-6815, 449, 854, 448, 304, 6618, 6124, 4346, 4344, 6126, 4342,
-6816, 856, 237, 106, 343, 6580, 3703, 7817, 8030, 3994, 3993,
-6817, 1275, 666, 1274, 610, 6342, 5762, 3263, 5617, 5079, 5763,
-6818, 1177, 581, 716, 651, 5510, 5230, 7909, 7440, 5021, 5233,
-6819, 106, 105, 856, 343, 1555, 7925, 7817, 3993, 3995, 8030,
-6820, 1263, 597, 554, 585, 7785, 4844, 7971, 6358, 4846, 4805,
-6821, 307, 857, 858, 35, 5521, 1945, 5519, 3914, 6052, 6179,
-6822, 1178, 676, 611, 653, 6349, 5106, 5909, 6360, 5105, 5036,
-6823, 846, 435, 436, 291, 7348, 4307, 7167, 7028, 4303, 4305,
-6824, 37, 818, 239, 36, 8029, 7342, 3711, 1560, 7363, 3710,
-6825, 700, 672, 1256, 710, 5182, 7612, 7276, 5312, 5311, 7277,
-6826, 1024, 349, 869, 313, 5508, 7698, 2477, 7635, 4100, 7634,
-6827, 345, 365, 456, 1014, 4109, 4369, 4368, 7194, 7192, 6116,
-6828, 999, 281, 921, 365, 5694, 5695, 2404, 5898, 4108, 5897,
-6829, 1211, 607, 580, 651, 6198, 4880, 8057, 6199, 5046, 5045,
-6830, 607, 662, 1276, 717, 5071, 7791, 5994, 5231, 5235, 5962,
-6831, 570, 598, 1209, 610, 4879, 6390, 7434, 4890, 4889, 5618,
-6832, 1079, 598, 570, 477, 6389, 4879, 8005, 7915, 4849, 4741,
-6833, 369, 598, 1079, 477, 4848, 6389, 7927, 4433, 4849, 7915,
-6834, 1372, 772, 744, 1356, 6475, 5466, 7830, 1635, 6958, 7614,
-6835, 280, 1005, 921, 365, 6352, 2423, 6636, 4107, 5899, 5897,
-6836, 669, 697, 1281, 653, 5250, 6357, 6049, 5086, 5174, 5829,
-6837, 56, 202, 879, 57, 7495, 2007, 7895, 1580, 6242, 7900,
-6838, 1299, 699, 1342, 740, 7661, 6541, 3142, 7409, 5185, 6829,
-6839, 1240, 1289, 710, 1270, 3450, 7279, 6288, 3384, 3207, 6812,
-6840, 184, 861, 39, 862, 1953, 6144, 7514, 1955, 1957, 6158,
-6841, 1327, 1344, 727, 1314, 1728, 7837, 7836, 3126, 2727, 7806,
-6842, 409, 262, 986, 408, 4223, 7771, 8015, 4225, 4221, 6948,
-6843, 414, 267, 832, 413, 4238, 5549, 5859, 4240, 4236, 5547,
-6844, 1354, 767, 770, 756, 6365, 5454, 6364, 6282, 5453, 5432,
-6845, 183, 38, 184, 861, 5923, 5924, 1420, 1952, 6146, 1953,
-6846, 1361, 1367, 779, 1366, 1619, 6538, 7832, 1620, 1611, 6539,
-6847, 228, 156, 16, 15, 5990, 3566, 3684, 3685, 3563, 1508,
-6848, 881, 58, 880, 203, 5597, 5596, 2014, 2012, 6171, 2010,
-6849, 689, 1289, 700, 688, 7365, 7278, 5193, 5179, 7377, 5183,
-6850, 1343, 770, 1354, 1336, 6969, 6364, 1673, 1718, 7814, 1704,
-6851, 66, 211, 67, 833, 6335, 7446, 1590, 6333, 1892, 6800,
-6852, 49, 48, 314, 871, 1572, 3929, 3928, 6622, 6586, 6621,
-6853, 428, 996, 429, 532, 7819, 5716, 4286, 4622, 5718, 4623,
-6854, 912, 830, 262, 409, 2199, 5913, 7425, 8016, 5886, 4223,
-6855, 656, 655, 681, 1191, 5053, 5123, 5125, 5787, 7865, 7864,
-6856, 1195, 632, 644, 655, 6182, 5048, 7055, 7870, 5047, 5049,
-6857, 70, 917, 272, 69, 7067, 6985, 3810, 1593, 6986, 3809,
-6858, 873, 1028, 351, 315, 2489, 6565, 6623, 7781, 5998, 4085,
-6859, 194, 48, 49, 871, 6584, 1572, 7325, 1983, 6586, 6622,
-6860, 788, 332, 943, 787, 6031, 8049, 2241, 1772, 7984, 2240,
-6861, 1192, 1246, 637, 707, 3307, 5879, 6112, 5800, 6113, 5205,
-6862, 383, 332, 943, 788, 4147, 8049, 5702, 5703, 6031, 2241,
-6863, 1255, 747, 748, 1192, 5937, 5345, 7378, 3335, 5938, 6096,
-6864, 943, 332, 383, 366, 8049, 4147, 5702, 5888, 4111, 4148,
-6865, 382, 225, 942, 366, 4143, 7113, 7112, 4145, 4112, 5887,
-6866, 1112, 634, 537, 1065, 7468, 4959, 7467, 2783, 7477, 6420,
-6867, 537, 536, 1065, 634, 4640, 7476, 6420, 4959, 4958, 7477,
-6868, 925, 116, 287, 117, 2126, 6959, 5874, 2125, 1470, 7946,
-6869, 726, 1289, 1340, 745, 7364, 3193, 5968, 5338, 7924, 5970,
-6870, 243, 390, 977, 975, 4166, 6084, 6861, 6528, 6085, 2344,
-6871, 467, 466, 1139, 1037, 4477, 7544, 7906, 7907, 7236, 2866,
-6872, 813, 236, 342, 31, 7850, 4083, 5916, 6208, 3701, 3989,
-6873, 32, 236, 176, 31, 3700, 8072, 3602, 1524, 3701, 3599,
-6874, 814, 236, 176, 32, 5613, 8072, 1848, 7107, 3700, 3602,
-6875, 1361, 1366, 779, 753, 1620, 6539, 7832, 7737, 6415, 5484,
-6876, 405, 258, 259, 985, 4211, 3772, 4212, 6109, 7445, 6111,
-6877, 793, 949, 228, 794, 2258, 6894, 6409, 1790, 2259, 5959,
-6878, 1312, 683, 694, 1242, 7753, 5184, 7947, 3527, 7859, 6104,
-6879, 538, 1000, 539, 1171, 7373, 7087, 4647, 6312, 2978, 7594,
-6880, 61, 884, 206, 883, 6651, 2021, 6680, 6654, 2023, 2019,
-6881, 176, 236, 813, 31, 8072, 7850, 1846, 3599, 3701, 6208,
-6882, 176, 236, 814, 813, 8072, 5613, 1848, 1846, 7850, 1850,
-6883, 44, 312, 867, 866, 3925, 6399, 6397, 5588, 7956, 1972,
-6884, 261, 829, 260, 58, 8013, 6760, 3778, 3776, 7994, 3774,
-6885, 261, 58, 59, 829, 3776, 1582, 3777, 8013, 7994, 7887,
-6886, 868, 312, 45, 349, 7590, 3924, 6772, 5509, 4059, 4011,
-6887, 1153, 1052, 474, 1051, 2909, 6417, 7763, 2908, 2562, 6418,
-6888, 312, 1022, 866, 348, 6090, 2470, 7956, 4101, 7905, 5589,
-6889, 698, 1307, 1313, 1317, 5775, 1734, 6581, 6583, 3367, 3411,
-6890, 987, 411, 264, 410, 7969, 4229, 7185, 5921, 4231, 4227,
-6891, 1023, 312, 349, 457, 5698, 4059, 5507, 5697, 4372, 4371,
-6892, 174, 173, 29, 811, 1409, 3594, 3596, 1840, 1839, 7052,
-6893, 668, 1313, 721, 684, 6551, 6552, 5282, 5133, 7731, 5332,
-6894, 1242, 1238, 624, 1181, 3286, 6848, 7480, 3285, 3272, 5576,
-6895, 264, 62, 207, 61, 3786, 7622, 7809, 3785, 1585, 7888,
-6896, 1022, 867, 1023, 312, 2471, 2473, 2475, 6090, 6399, 5698,
-6897, 1321, 750, 675, 1324, 7258, 5353, 5987, 1738, 7904, 5989,
-6898, 44, 312, 866, 348, 3925, 7956, 5588, 4008, 4101, 5589,
-6899, 539, 1170, 540, 637, 7131, 7126, 4650, 4967, 5880, 4968,
-6900, 447, 853, 934, 302, 5725, 2215, 7272, 4338, 7992, 7216,
-6901, 1253, 589, 1239, 588, 7124, 7207, 3328, 7125, 4818, 8009,
-6902, 505, 588, 504, 1239, 4814, 4813, 4539, 6313, 8009, 6314,
-6903, 580, 607, 1176, 598, 4880, 8035, 7603, 4862, 4881, 6899,
-6904, 505, 588, 1239, 589, 4814, 8009, 6313, 4817, 4818, 7207,
-6905, 306, 937, 140, 105, 6429, 2151, 6428, 3912, 7926, 3668,
-6906, 548, 448, 449, 1071, 4674, 4346, 4847, 5665, 5666, 5809,
-6907, 108, 839, 78, 107, 1905, 6505, 3609, 1461, 1906, 3608,
-6908, 1040, 884, 357, 1039, 2524, 6652, 7395, 2526, 2522, 7549,
-6909, 208, 885, 63, 886, 2025, 7291, 7722, 2027, 2029, 6185,
-6910, 1034, 464, 1033, 354, 7707, 7691, 2508, 7528, 4394, 7525,
-6911, 1357, 1333, 713, 1345, 1693, 7048, 7047, 1683, 1713, 7018,
-6912, 647, 552, 1230, 1261, 5002, 6967, 6560, 5540, 7773, 3350,
-6913, 318, 465, 1034, 354, 4396, 7708, 7767, 4088, 4397, 7528,
-6914, 1033, 464, 317, 354, 7691, 4395, 7327, 7525, 4394, 4064,
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/precice-config.xml b/FSI/3D_Tube/OpenFOAM-CalculiX/precice-config.xml
deleted file mode 100644
index 0d32c859d..000000000
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/precice-config.xml
+++ /dev/null
@@ -1,68 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/removeObsoleteFolders.sh b/FSI/3D_Tube/OpenFOAM-CalculiX/removeObsoleteFolders.sh
deleted file mode 100755
index 80288fe27..000000000
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,23 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
-
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Allclean b/FSI/cylinderFlap/OpenFOAM-CalculiX/Allclean
deleted file mode 100755
index 785470459..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Allclean
+++ /dev/null
@@ -1,62 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- rm -rfv 0
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_potentialFoam.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid
-Participant2="Solid"
-cd ${Participant2}
- # Clean the case
- rm -fv *.log
- rm -fv flap.cvg
- rm -fv flap.dat
- rm -fv flap.frd
- rm -fv flap.sta
- rm -fv flap.12d
-cd ..
-# Remove the log files
-rm -fv spooles.out
-rm -fv ${Participant2}.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-postProcessingInfo.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Allrun b/FSI/cylinderFlap/OpenFOAM-CalculiX/Allrun
deleted file mode 100755
index a78cc8c07..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Allrun
+++ /dev/null
@@ -1,120 +0,0 @@
-#!/bin/bash
-
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the scripts "runSolid" and "runFluid"
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- echo " Restoring 0/ from 0.orig/..."
- rm -rfv 0
- cp -r 0.orig 0
- cd ..
-
- echo " Preparing the mesh..."
- blockMesh -case ${Participant1} > ${Participant1}_blockMesh.log 2>&1
- checkMesh -case ${Participant1} > ${Participant1}_checkMesh.log 2>&1
-
- # Initialize the internal field with a potential flow
- potentialFoam -case ${Participant1} > ${Participant1}_potentialFoam.log 2>&1
-
- # get application information
- cd ${Participant1}
- Solver1=$(getApplication) # solver
- echo " ${Participant1} Solver: ${Solver1}."
- cd ..
-
- # Run and get the process id
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-Solver2="ccx_preCICE"
-
- # You can use CalculiX CGX to setup the structural simulation from sratch.
- # This will re-generate the all.msh, fix1.nam, surface.nam files.
- #
- # # Prepare in silent mode
- # echo "Preparing the ${Participant2} participant..."
- # cd ${Participant2}
- # echo " Executing cgx (provided by CalculiX, make sure this exists)..."
- # cgx -bg pre_flap.fbd > prepare_flap.log 2>&1
- # cd ..
-
- # Run
- echo " Starting the ${Participant2} participant..."
- ${Solver2} -i ${Participant2}/flap -precice-participant Calculix > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
- if [ $parallel -eq 1 ]; then
- echo "Reconstructing fields..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1 &
- fi
-
- # Workaround for issue #26
- echo "Problems with time directories without results? Run the script removeObsoleteFolders.sh and see issue #26 on GitHub."
- # ./removeObsoleteFolders.sh
-
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Allrun_parallel b/FSI/cylinderFlap/OpenFOAM-CalculiX/Allrun_parallel
deleted file mode 100755
index e333301db..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Allrun_parallel
+++ /dev/null
@@ -1 +0,0 @@
-./Allrun -parallel
\ No newline at end of file
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/Fluid.foam b/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/fvSchemes b/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/fvSchemes
deleted file mode 100644
index b2d960d05..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/fvSchemes
+++ /dev/null
@@ -1,53 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSchemes;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- ddtSchemes
- {
- default backward;
- }
-
- gradSchemes
- {
- default Gauss linear;
- }
-
- divSchemes
- {
- default none;
- div(phi,U) bounded Gauss linearUpwind limited;
- div((nuEff*dev2(T(grad(U))))) Gauss linear;
- }
-
- interpolationSchemes
- {
- default linear;
- }
-
- laplacianSchemes
- {
- default Gauss linear corrected;
- }
-
- snGradSchemes
- {
- default corrected;
- }
-
- wallDist
- {
- method meshWave;
- }
-
- fluxRequired
- {
- default no;
- p ;
- Phi ;
- }
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/fvSolution b/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/fvSolution
deleted file mode 100644
index 886a252ec..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/fvSolution
+++ /dev/null
@@ -1,97 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSolution;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-solvers
-{
- p
- {
- solver GAMG;
- tolerance 1e-10;
- relTol 1e-6;
- smoother DICGaussSeidel;
- }
-
- pFinal
- {
- $p;
- relTol 0;
- }
-
- pcorrFinal
- {
- $p;
- relTol 0;
- }
-
- Phi
- {
- $p;
- }
-
- "(U|cellDisplacement)"
- {
- solver smoothSolver;
- smoother symGaussSeidel;
- tolerance 1e-10;
- relTol 1e-6;
- }
-
- "(U|cellDisplacement)Final"
- {
- $U;
- relTol 0;
- }
-}
-
-PIMPLE
-{
- nCorrectors 2;
- nNonOrthogonalCorrectors 0;
- tolerance 1.0e-14;
- relTol 5e-3;
- pisoTol 1e-6;
- consistent true;
-
- nOuterCorrectors 50;
-
- // OpenFOAM (.com), OpenFOAM 5 or older (.org)
- /*
- residualControl
- {
- U
- {
- tolerance 5e-5;
- relTol 0;
- }
- p
- {
- tolerance 5e-4;
- relTol 0;
- }
- }
- */
-
- // OpenFOAM 6 (.org) or newer
- /*
- residualControl
- {
- U 5e-5;
- p 5e-4;
- }
- */
-}
-
-potentialFlow
-{
- nNonOrthogonalCorrectors 5;
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/README.md b/FSI/cylinderFlap/OpenFOAM-CalculiX/README.md
deleted file mode 100644
index 57b9ac6ae..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/README.md
+++ /dev/null
@@ -1,19 +0,0 @@
-# Tutorial for an FSI simulation of a cylinder-flap scenario
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-OpenFOAM-and-CalculiX).
-
-The case files are prepared for the latest versions of OpenFOAM and use the solver `pimpleFoam`. **In case you are using a previous OpenFOAM version** you need to adjust the solver to `pimpleDyMFoam` in the `Fluid/system/controlDict` file. Have a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-You may run the coupled simulation in serial using the script `Allrun` or in parallel with `Allrun -parallel` (`Allrun_parallel` is a shortcut to this). The output of each step will be redirected to log files. You can cleanup the simulation using `Allclean`.
-
-If you prefer to run the two simulations in two different terminals and watch their output on the screen, use the (simpler) scripts `runFluid` (or `runFluid -parallel`) and `runSolid`. Please always run the script `runFluid` first.
-
-There is an [open issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. Please run the script `removeObsoleteSolvers.sh` to delete the additional files.
-
-You may adjust the end time in the precice-config_*.xml, or interupt the execution earlier if you want.
-
-This case was contributed by Derek Risseeuw (TU Delft).
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/add_material.inp b/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/add_material.inp
deleted file mode 100644
index c27a194d9..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/add_material.inp
+++ /dev/null
@@ -1,12 +0,0 @@
-*MATERIAL,NAME=User
-*ELASTIC
-5.6000E+06,0.4
-
-
-*DENSITY
-1.0000E+03
-*EXPANSION
-0.0000E+00
-
-*SOLID SECTION,MATERIAL=User,ELSET=Eall
-
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/all.msh b/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/all.msh
deleted file mode 100644
index d67a54bc5..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/all.msh
+++ /dev/null
@@ -1,992 +0,0 @@
-*NODE, NSET=Nall
- 1,2.500000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 2,2.500000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 3,2.550000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 4,2.550000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 5,2.500000000000e-01,2.100000000000e-01,5.000000000000e-03
- 6,2.500000000000e-01,2.050000000000e-01,5.000000000000e-03
- 7,2.550000000000e-01,2.050000000000e-01,5.000000000000e-03
- 8,2.550000000000e-01,2.100000000000e-01,5.000000000000e-03
- 9,2.600000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 10,2.600000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 11,2.600000000000e-01,2.050000000000e-01,5.000000000000e-03
- 12,2.600000000000e-01,2.100000000000e-01,5.000000000000e-03
- 13,2.650000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 14,2.650000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 15,2.650000000000e-01,2.050000000000e-01,5.000000000000e-03
- 16,2.650000000000e-01,2.100000000000e-01,5.000000000000e-03
- 17,2.700000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 18,2.700000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 19,2.700000000000e-01,2.050000000000e-01,5.000000000000e-03
- 20,2.700000000000e-01,2.100000000000e-01,5.000000000000e-03
- 21,2.750000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 22,2.750000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 23,2.750000000000e-01,2.050000000000e-01,5.000000000000e-03
- 24,2.750000000000e-01,2.100000000000e-01,5.000000000000e-03
- 25,2.800000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 26,2.800000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 27,2.800000000000e-01,2.050000000000e-01,5.000000000000e-03
- 28,2.800000000000e-01,2.100000000000e-01,5.000000000000e-03
- 29,2.850000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 30,2.850000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 31,2.850000000000e-01,2.050000000000e-01,5.000000000000e-03
- 32,2.850000000000e-01,2.100000000000e-01,5.000000000000e-03
- 33,2.900000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 34,2.900000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 35,2.900000000000e-01,2.050000000000e-01,5.000000000000e-03
- 36,2.900000000000e-01,2.100000000000e-01,5.000000000000e-03
- 37,2.950000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 38,2.950000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 39,2.950000000000e-01,2.050000000000e-01,5.000000000000e-03
- 40,2.950000000000e-01,2.100000000000e-01,5.000000000000e-03
- 41,3.000000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 42,3.000000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 43,3.000000000000e-01,2.050000000000e-01,5.000000000000e-03
- 44,3.000000000000e-01,2.100000000000e-01,5.000000000000e-03
- 45,3.050000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 46,3.050000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 47,3.050000000000e-01,2.050000000000e-01,5.000000000000e-03
- 48,3.050000000000e-01,2.100000000000e-01,5.000000000000e-03
- 49,3.100000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 50,3.100000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 51,3.100000000000e-01,2.050000000000e-01,5.000000000000e-03
- 52,3.100000000000e-01,2.100000000000e-01,5.000000000000e-03
- 53,3.150000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 54,3.150000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 55,3.150000000000e-01,2.050000000000e-01,5.000000000000e-03
- 56,3.150000000000e-01,2.100000000000e-01,5.000000000000e-03
- 57,3.200000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 58,3.200000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 59,3.200000000000e-01,2.050000000000e-01,5.000000000000e-03
- 60,3.200000000000e-01,2.100000000000e-01,5.000000000000e-03
- 61,3.250000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 62,3.250000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 63,3.250000000000e-01,2.050000000000e-01,5.000000000000e-03
- 64,3.250000000000e-01,2.100000000000e-01,5.000000000000e-03
- 65,3.300000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 66,3.300000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 67,3.300000000000e-01,2.050000000000e-01,5.000000000000e-03
- 68,3.300000000000e-01,2.100000000000e-01,5.000000000000e-03
- 69,3.350000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 70,3.350000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 71,3.350000000000e-01,2.050000000000e-01,5.000000000000e-03
- 72,3.350000000000e-01,2.100000000000e-01,5.000000000000e-03
- 73,3.400000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 74,3.400000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 75,3.400000000000e-01,2.050000000000e-01,5.000000000000e-03
- 76,3.400000000000e-01,2.100000000000e-01,5.000000000000e-03
- 77,3.450000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 78,3.450000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 79,3.450000000000e-01,2.050000000000e-01,5.000000000000e-03
- 80,3.450000000000e-01,2.100000000000e-01,5.000000000000e-03
- 81,3.500000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 82,3.500000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 83,3.500000000000e-01,2.050000000000e-01,5.000000000000e-03
- 84,3.500000000000e-01,2.100000000000e-01,5.000000000000e-03
- 85,3.550000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 86,3.550000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 87,3.550000000000e-01,2.050000000000e-01,5.000000000000e-03
- 88,3.550000000000e-01,2.100000000000e-01,5.000000000000e-03
- 89,3.600000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 90,3.600000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 91,3.600000000000e-01,2.050000000000e-01,5.000000000000e-03
- 92,3.600000000000e-01,2.100000000000e-01,5.000000000000e-03
- 93,3.650000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 94,3.650000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 95,3.650000000000e-01,2.050000000000e-01,5.000000000000e-03
- 96,3.650000000000e-01,2.100000000000e-01,5.000000000000e-03
- 97,3.700000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 98,3.700000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 99,3.700000000000e-01,2.050000000000e-01,5.000000000000e-03
- 100,3.700000000000e-01,2.100000000000e-01,5.000000000000e-03
- 101,3.750000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 102,3.750000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 103,3.750000000000e-01,2.050000000000e-01,5.000000000000e-03
- 104,3.750000000000e-01,2.100000000000e-01,5.000000000000e-03
- 105,3.800000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 106,3.800000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 107,3.800000000000e-01,2.050000000000e-01,5.000000000000e-03
- 108,3.800000000000e-01,2.100000000000e-01,5.000000000000e-03
- 109,3.850000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 110,3.850000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 111,3.850000000000e-01,2.050000000000e-01,5.000000000000e-03
- 112,3.850000000000e-01,2.100000000000e-01,5.000000000000e-03
- 113,3.900000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 114,3.900000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 115,3.900000000000e-01,2.050000000000e-01,5.000000000000e-03
- 116,3.900000000000e-01,2.100000000000e-01,5.000000000000e-03
- 117,3.950000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 118,3.950000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 119,3.950000000000e-01,2.050000000000e-01,5.000000000000e-03
- 120,3.950000000000e-01,2.100000000000e-01,5.000000000000e-03
- 121,4.000000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 122,4.000000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 123,4.000000000000e-01,2.050000000000e-01,5.000000000000e-03
- 124,4.000000000000e-01,2.100000000000e-01,5.000000000000e-03
- 125,4.050000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 126,4.050000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 127,4.050000000000e-01,2.050000000000e-01,5.000000000000e-03
- 128,4.050000000000e-01,2.100000000000e-01,5.000000000000e-03
- 129,4.100000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 130,4.100000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 131,4.100000000000e-01,2.050000000000e-01,5.000000000000e-03
- 132,4.100000000000e-01,2.100000000000e-01,5.000000000000e-03
- 133,4.150000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 134,4.150000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 135,4.150000000000e-01,2.050000000000e-01,5.000000000000e-03
- 136,4.150000000000e-01,2.100000000000e-01,5.000000000000e-03
- 137,4.200000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 138,4.200000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 139,4.200000000000e-01,2.050000000000e-01,5.000000000000e-03
- 140,4.200000000000e-01,2.100000000000e-01,5.000000000000e-03
- 141,4.250000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 142,4.250000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 143,4.250000000000e-01,2.050000000000e-01,5.000000000000e-03
- 144,4.250000000000e-01,2.100000000000e-01,5.000000000000e-03
- 145,4.300000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 146,4.300000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 147,4.300000000000e-01,2.050000000000e-01,5.000000000000e-03
- 148,4.300000000000e-01,2.100000000000e-01,5.000000000000e-03
- 149,4.350000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 150,4.350000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 151,4.350000000000e-01,2.050000000000e-01,5.000000000000e-03
- 152,4.350000000000e-01,2.100000000000e-01,5.000000000000e-03
- 153,4.400000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 154,4.400000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 155,4.400000000000e-01,2.050000000000e-01,5.000000000000e-03
- 156,4.400000000000e-01,2.100000000000e-01,5.000000000000e-03
- 157,4.450000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 158,4.450000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 159,4.450000000000e-01,2.050000000000e-01,5.000000000000e-03
- 160,4.450000000000e-01,2.100000000000e-01,5.000000000000e-03
- 161,4.500000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 162,4.500000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 163,4.500000000000e-01,2.050000000000e-01,5.000000000000e-03
- 164,4.500000000000e-01,2.100000000000e-01,5.000000000000e-03
- 165,4.550000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 166,4.550000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 167,4.550000000000e-01,2.050000000000e-01,5.000000000000e-03
- 168,4.550000000000e-01,2.100000000000e-01,5.000000000000e-03
- 169,4.600000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 170,4.600000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 171,4.600000000000e-01,2.050000000000e-01,5.000000000000e-03
- 172,4.600000000000e-01,2.100000000000e-01,5.000000000000e-03
- 173,4.650000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 174,4.650000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 175,4.650000000000e-01,2.050000000000e-01,5.000000000000e-03
- 176,4.650000000000e-01,2.100000000000e-01,5.000000000000e-03
- 177,4.700000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 178,4.700000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 179,4.700000000000e-01,2.050000000000e-01,5.000000000000e-03
- 180,4.700000000000e-01,2.100000000000e-01,5.000000000000e-03
- 181,4.750000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 182,4.750000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 183,4.750000000000e-01,2.050000000000e-01,5.000000000000e-03
- 184,4.750000000000e-01,2.100000000000e-01,5.000000000000e-03
- 185,4.800000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 186,4.800000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 187,4.800000000000e-01,2.050000000000e-01,5.000000000000e-03
- 188,4.800000000000e-01,2.100000000000e-01,5.000000000000e-03
- 189,4.850000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 190,4.850000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 191,4.850000000000e-01,2.050000000000e-01,5.000000000000e-03
- 192,4.850000000000e-01,2.100000000000e-01,5.000000000000e-03
- 193,4.900000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 194,4.900000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 195,4.900000000000e-01,2.050000000000e-01,5.000000000000e-03
- 196,4.900000000000e-01,2.100000000000e-01,5.000000000000e-03
- 197,4.950000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 198,4.950000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 199,4.950000000000e-01,2.050000000000e-01,5.000000000000e-03
- 200,4.950000000000e-01,2.100000000000e-01,5.000000000000e-03
- 201,5.000000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 202,5.000000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 203,5.000000000000e-01,2.050000000000e-01,5.000000000000e-03
- 204,5.000000000000e-01,2.100000000000e-01,5.000000000000e-03
- 205,5.050000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 206,5.050000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 207,5.050000000000e-01,2.050000000000e-01,5.000000000000e-03
- 208,5.050000000000e-01,2.100000000000e-01,5.000000000000e-03
- 209,5.100000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 210,5.100000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 211,5.100000000000e-01,2.050000000000e-01,5.000000000000e-03
- 212,5.100000000000e-01,2.100000000000e-01,5.000000000000e-03
- 213,5.150000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 214,5.150000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 215,5.150000000000e-01,2.050000000000e-01,5.000000000000e-03
- 216,5.150000000000e-01,2.100000000000e-01,5.000000000000e-03
- 217,5.200000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 218,5.200000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 219,5.200000000000e-01,2.050000000000e-01,5.000000000000e-03
- 220,5.200000000000e-01,2.100000000000e-01,5.000000000000e-03
- 221,5.250000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 222,5.250000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 223,5.250000000000e-01,2.050000000000e-01,5.000000000000e-03
- 224,5.250000000000e-01,2.100000000000e-01,5.000000000000e-03
- 225,5.300000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 226,5.300000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 227,5.300000000000e-01,2.050000000000e-01,5.000000000000e-03
- 228,5.300000000000e-01,2.100000000000e-01,5.000000000000e-03
- 229,5.350000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 230,5.350000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 231,5.350000000000e-01,2.050000000000e-01,5.000000000000e-03
- 232,5.350000000000e-01,2.100000000000e-01,5.000000000000e-03
- 233,5.400000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 234,5.400000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 235,5.400000000000e-01,2.050000000000e-01,5.000000000000e-03
- 236,5.400000000000e-01,2.100000000000e-01,5.000000000000e-03
- 237,5.450000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 238,5.450000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 239,5.450000000000e-01,2.050000000000e-01,5.000000000000e-03
- 240,5.450000000000e-01,2.100000000000e-01,5.000000000000e-03
- 241,5.500000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 242,5.500000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 243,5.500000000000e-01,2.050000000000e-01,5.000000000000e-03
- 244,5.500000000000e-01,2.100000000000e-01,5.000000000000e-03
- 245,5.550000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 246,5.550000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 247,5.550000000000e-01,2.050000000000e-01,5.000000000000e-03
- 248,5.550000000000e-01,2.100000000000e-01,5.000000000000e-03
- 249,5.600000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 250,5.600000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 251,5.600000000000e-01,2.050000000000e-01,5.000000000000e-03
- 252,5.600000000000e-01,2.100000000000e-01,5.000000000000e-03
- 253,5.650000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 254,5.650000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 255,5.650000000000e-01,2.050000000000e-01,5.000000000000e-03
- 256,5.650000000000e-01,2.100000000000e-01,5.000000000000e-03
- 257,5.700000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 258,5.700000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 259,5.700000000000e-01,2.050000000000e-01,5.000000000000e-03
- 260,5.700000000000e-01,2.100000000000e-01,5.000000000000e-03
- 261,5.750000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 262,5.750000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 263,5.750000000000e-01,2.050000000000e-01,5.000000000000e-03
- 264,5.750000000000e-01,2.100000000000e-01,5.000000000000e-03
- 265,5.800000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 266,5.800000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 267,5.800000000000e-01,2.050000000000e-01,5.000000000000e-03
- 268,5.800000000000e-01,2.100000000000e-01,5.000000000000e-03
- 269,5.850000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 270,5.850000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 271,5.850000000000e-01,2.050000000000e-01,5.000000000000e-03
- 272,5.850000000000e-01,2.100000000000e-01,5.000000000000e-03
- 273,5.900000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 274,5.900000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 275,5.900000000000e-01,2.050000000000e-01,5.000000000000e-03
- 276,5.900000000000e-01,2.100000000000e-01,5.000000000000e-03
- 277,5.950000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 278,5.950000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 279,5.950000000000e-01,2.050000000000e-01,5.000000000000e-03
- 280,5.950000000000e-01,2.100000000000e-01,5.000000000000e-03
- 281,6.000000000000e-01,2.050000000000e-01,-5.000000000000e-03
- 282,6.000000000000e-01,2.100000000000e-01,-5.000000000000e-03
- 283,6.000000000000e-01,2.050000000000e-01,5.000000000000e-03
- 284,6.000000000000e-01,2.100000000000e-01,5.000000000000e-03
- 285,2.500000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 286,2.550000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 287,2.500000000000e-01,2.000000000000e-01,5.000000000000e-03
- 288,2.550000000000e-01,2.000000000000e-01,5.000000000000e-03
- 289,2.600000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 290,2.600000000000e-01,2.000000000000e-01,5.000000000000e-03
- 291,2.650000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 292,2.650000000000e-01,2.000000000000e-01,5.000000000000e-03
- 293,2.700000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 294,2.700000000000e-01,2.000000000000e-01,5.000000000000e-03
- 295,2.750000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 296,2.750000000000e-01,2.000000000000e-01,5.000000000000e-03
- 297,2.800000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 298,2.800000000000e-01,2.000000000000e-01,5.000000000000e-03
- 299,2.850000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 300,2.850000000000e-01,2.000000000000e-01,5.000000000000e-03
- 301,2.900000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 302,2.900000000000e-01,2.000000000000e-01,5.000000000000e-03
- 303,2.950000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 304,2.950000000000e-01,2.000000000000e-01,5.000000000000e-03
- 305,3.000000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 306,3.000000000000e-01,2.000000000000e-01,5.000000000000e-03
- 307,3.050000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 308,3.050000000000e-01,2.000000000000e-01,5.000000000000e-03
- 309,3.100000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 310,3.100000000000e-01,2.000000000000e-01,5.000000000000e-03
- 311,3.150000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 312,3.150000000000e-01,2.000000000000e-01,5.000000000000e-03
- 313,3.200000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 314,3.200000000000e-01,2.000000000000e-01,5.000000000000e-03
- 315,3.250000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 316,3.250000000000e-01,2.000000000000e-01,5.000000000000e-03
- 317,3.300000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 318,3.300000000000e-01,2.000000000000e-01,5.000000000000e-03
- 319,3.350000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 320,3.350000000000e-01,2.000000000000e-01,5.000000000000e-03
- 321,3.400000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 322,3.400000000000e-01,2.000000000000e-01,5.000000000000e-03
- 323,3.450000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 324,3.450000000000e-01,2.000000000000e-01,5.000000000000e-03
- 325,3.500000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 326,3.500000000000e-01,2.000000000000e-01,5.000000000000e-03
- 327,3.550000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 328,3.550000000000e-01,2.000000000000e-01,5.000000000000e-03
- 329,3.600000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 330,3.600000000000e-01,2.000000000000e-01,5.000000000000e-03
- 331,3.650000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 332,3.650000000000e-01,2.000000000000e-01,5.000000000000e-03
- 333,3.700000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 334,3.700000000000e-01,2.000000000000e-01,5.000000000000e-03
- 335,3.750000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 336,3.750000000000e-01,2.000000000000e-01,5.000000000000e-03
- 337,3.800000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 338,3.800000000000e-01,2.000000000000e-01,5.000000000000e-03
- 339,3.850000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 340,3.850000000000e-01,2.000000000000e-01,5.000000000000e-03
- 341,3.900000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 342,3.900000000000e-01,2.000000000000e-01,5.000000000000e-03
- 343,3.950000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 344,3.950000000000e-01,2.000000000000e-01,5.000000000000e-03
- 345,4.000000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 346,4.000000000000e-01,2.000000000000e-01,5.000000000000e-03
- 347,4.050000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 348,4.050000000000e-01,2.000000000000e-01,5.000000000000e-03
- 349,4.100000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 350,4.100000000000e-01,2.000000000000e-01,5.000000000000e-03
- 351,4.150000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 352,4.150000000000e-01,2.000000000000e-01,5.000000000000e-03
- 353,4.200000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 354,4.200000000000e-01,2.000000000000e-01,5.000000000000e-03
- 355,4.250000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 356,4.250000000000e-01,2.000000000000e-01,5.000000000000e-03
- 357,4.300000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 358,4.300000000000e-01,2.000000000000e-01,5.000000000000e-03
- 359,4.350000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 360,4.350000000000e-01,2.000000000000e-01,5.000000000000e-03
- 361,4.400000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 362,4.400000000000e-01,2.000000000000e-01,5.000000000000e-03
- 363,4.450000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 364,4.450000000000e-01,2.000000000000e-01,5.000000000000e-03
- 365,4.500000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 366,4.500000000000e-01,2.000000000000e-01,5.000000000000e-03
- 367,4.550000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 368,4.550000000000e-01,2.000000000000e-01,5.000000000000e-03
- 369,4.600000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 370,4.600000000000e-01,2.000000000000e-01,5.000000000000e-03
- 371,4.650000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 372,4.650000000000e-01,2.000000000000e-01,5.000000000000e-03
- 373,4.700000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 374,4.700000000000e-01,2.000000000000e-01,5.000000000000e-03
- 375,4.750000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 376,4.750000000000e-01,2.000000000000e-01,5.000000000000e-03
- 377,4.800000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 378,4.800000000000e-01,2.000000000000e-01,5.000000000000e-03
- 379,4.850000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 380,4.850000000000e-01,2.000000000000e-01,5.000000000000e-03
- 381,4.900000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 382,4.900000000000e-01,2.000000000000e-01,5.000000000000e-03
- 383,4.950000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 384,4.950000000000e-01,2.000000000000e-01,5.000000000000e-03
- 385,5.000000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 386,5.000000000000e-01,2.000000000000e-01,5.000000000000e-03
- 387,5.050000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 388,5.050000000000e-01,2.000000000000e-01,5.000000000000e-03
- 389,5.100000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 390,5.100000000000e-01,2.000000000000e-01,5.000000000000e-03
- 391,5.150000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 392,5.150000000000e-01,2.000000000000e-01,5.000000000000e-03
- 393,5.200000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 394,5.200000000000e-01,2.000000000000e-01,5.000000000000e-03
- 395,5.250000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 396,5.250000000000e-01,2.000000000000e-01,5.000000000000e-03
- 397,5.300000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 398,5.300000000000e-01,2.000000000000e-01,5.000000000000e-03
- 399,5.350000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 400,5.350000000000e-01,2.000000000000e-01,5.000000000000e-03
- 401,5.400000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 402,5.400000000000e-01,2.000000000000e-01,5.000000000000e-03
- 403,5.450000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 404,5.450000000000e-01,2.000000000000e-01,5.000000000000e-03
- 405,5.500000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 406,5.500000000000e-01,2.000000000000e-01,5.000000000000e-03
- 407,5.550000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 408,5.550000000000e-01,2.000000000000e-01,5.000000000000e-03
- 409,5.600000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 410,5.600000000000e-01,2.000000000000e-01,5.000000000000e-03
- 411,5.650000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 412,5.650000000000e-01,2.000000000000e-01,5.000000000000e-03
- 413,5.700000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 414,5.700000000000e-01,2.000000000000e-01,5.000000000000e-03
- 415,5.750000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 416,5.750000000000e-01,2.000000000000e-01,5.000000000000e-03
- 417,5.800000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 418,5.800000000000e-01,2.000000000000e-01,5.000000000000e-03
- 419,5.850000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 420,5.850000000000e-01,2.000000000000e-01,5.000000000000e-03
- 421,5.900000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 422,5.900000000000e-01,2.000000000000e-01,5.000000000000e-03
- 423,5.950000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 424,5.950000000000e-01,2.000000000000e-01,5.000000000000e-03
- 425,6.000000000000e-01,2.000000000000e-01,-5.000000000000e-03
- 426,6.000000000000e-01,2.000000000000e-01,5.000000000000e-03
- 427,2.500000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 428,2.550000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 429,2.500000000000e-01,1.950000000000e-01,5.000000000000e-03
- 430,2.550000000000e-01,1.950000000000e-01,5.000000000000e-03
- 431,2.600000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 432,2.600000000000e-01,1.950000000000e-01,5.000000000000e-03
- 433,2.650000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 434,2.650000000000e-01,1.950000000000e-01,5.000000000000e-03
- 435,2.700000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 436,2.700000000000e-01,1.950000000000e-01,5.000000000000e-03
- 437,2.750000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 438,2.750000000000e-01,1.950000000000e-01,5.000000000000e-03
- 439,2.800000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 440,2.800000000000e-01,1.950000000000e-01,5.000000000000e-03
- 441,2.850000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 442,2.850000000000e-01,1.950000000000e-01,5.000000000000e-03
- 443,2.900000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 444,2.900000000000e-01,1.950000000000e-01,5.000000000000e-03
- 445,2.950000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 446,2.950000000000e-01,1.950000000000e-01,5.000000000000e-03
- 447,3.000000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 448,3.000000000000e-01,1.950000000000e-01,5.000000000000e-03
- 449,3.050000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 450,3.050000000000e-01,1.950000000000e-01,5.000000000000e-03
- 451,3.100000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 452,3.100000000000e-01,1.950000000000e-01,5.000000000000e-03
- 453,3.150000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 454,3.150000000000e-01,1.950000000000e-01,5.000000000000e-03
- 455,3.200000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 456,3.200000000000e-01,1.950000000000e-01,5.000000000000e-03
- 457,3.250000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 458,3.250000000000e-01,1.950000000000e-01,5.000000000000e-03
- 459,3.300000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 460,3.300000000000e-01,1.950000000000e-01,5.000000000000e-03
- 461,3.350000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 462,3.350000000000e-01,1.950000000000e-01,5.000000000000e-03
- 463,3.400000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 464,3.400000000000e-01,1.950000000000e-01,5.000000000000e-03
- 465,3.450000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 466,3.450000000000e-01,1.950000000000e-01,5.000000000000e-03
- 467,3.500000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 468,3.500000000000e-01,1.950000000000e-01,5.000000000000e-03
- 469,3.550000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 470,3.550000000000e-01,1.950000000000e-01,5.000000000000e-03
- 471,3.600000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 472,3.600000000000e-01,1.950000000000e-01,5.000000000000e-03
- 473,3.650000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 474,3.650000000000e-01,1.950000000000e-01,5.000000000000e-03
- 475,3.700000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 476,3.700000000000e-01,1.950000000000e-01,5.000000000000e-03
- 477,3.750000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 478,3.750000000000e-01,1.950000000000e-01,5.000000000000e-03
- 479,3.800000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 480,3.800000000000e-01,1.950000000000e-01,5.000000000000e-03
- 481,3.850000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 482,3.850000000000e-01,1.950000000000e-01,5.000000000000e-03
- 483,3.900000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 484,3.900000000000e-01,1.950000000000e-01,5.000000000000e-03
- 485,3.950000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 486,3.950000000000e-01,1.950000000000e-01,5.000000000000e-03
- 487,4.000000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 488,4.000000000000e-01,1.950000000000e-01,5.000000000000e-03
- 489,4.050000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 490,4.050000000000e-01,1.950000000000e-01,5.000000000000e-03
- 491,4.100000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 492,4.100000000000e-01,1.950000000000e-01,5.000000000000e-03
- 493,4.150000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 494,4.150000000000e-01,1.950000000000e-01,5.000000000000e-03
- 495,4.200000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 496,4.200000000000e-01,1.950000000000e-01,5.000000000000e-03
- 497,4.250000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 498,4.250000000000e-01,1.950000000000e-01,5.000000000000e-03
- 499,4.300000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 500,4.300000000000e-01,1.950000000000e-01,5.000000000000e-03
- 501,4.350000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 502,4.350000000000e-01,1.950000000000e-01,5.000000000000e-03
- 503,4.400000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 504,4.400000000000e-01,1.950000000000e-01,5.000000000000e-03
- 505,4.450000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 506,4.450000000000e-01,1.950000000000e-01,5.000000000000e-03
- 507,4.500000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 508,4.500000000000e-01,1.950000000000e-01,5.000000000000e-03
- 509,4.550000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 510,4.550000000000e-01,1.950000000000e-01,5.000000000000e-03
- 511,4.600000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 512,4.600000000000e-01,1.950000000000e-01,5.000000000000e-03
- 513,4.650000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 514,4.650000000000e-01,1.950000000000e-01,5.000000000000e-03
- 515,4.700000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 516,4.700000000000e-01,1.950000000000e-01,5.000000000000e-03
- 517,4.750000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 518,4.750000000000e-01,1.950000000000e-01,5.000000000000e-03
- 519,4.800000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 520,4.800000000000e-01,1.950000000000e-01,5.000000000000e-03
- 521,4.850000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 522,4.850000000000e-01,1.950000000000e-01,5.000000000000e-03
- 523,4.900000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 524,4.900000000000e-01,1.950000000000e-01,5.000000000000e-03
- 525,4.950000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 526,4.950000000000e-01,1.950000000000e-01,5.000000000000e-03
- 527,5.000000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 528,5.000000000000e-01,1.950000000000e-01,5.000000000000e-03
- 529,5.050000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 530,5.050000000000e-01,1.950000000000e-01,5.000000000000e-03
- 531,5.100000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 532,5.100000000000e-01,1.950000000000e-01,5.000000000000e-03
- 533,5.150000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 534,5.150000000000e-01,1.950000000000e-01,5.000000000000e-03
- 535,5.200000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 536,5.200000000000e-01,1.950000000000e-01,5.000000000000e-03
- 537,5.250000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 538,5.250000000000e-01,1.950000000000e-01,5.000000000000e-03
- 539,5.300000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 540,5.300000000000e-01,1.950000000000e-01,5.000000000000e-03
- 541,5.350000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 542,5.350000000000e-01,1.950000000000e-01,5.000000000000e-03
- 543,5.400000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 544,5.400000000000e-01,1.950000000000e-01,5.000000000000e-03
- 545,5.450000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 546,5.450000000000e-01,1.950000000000e-01,5.000000000000e-03
- 547,5.500000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 548,5.500000000000e-01,1.950000000000e-01,5.000000000000e-03
- 549,5.550000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 550,5.550000000000e-01,1.950000000000e-01,5.000000000000e-03
- 551,5.600000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 552,5.600000000000e-01,1.950000000000e-01,5.000000000000e-03
- 553,5.650000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 554,5.650000000000e-01,1.950000000000e-01,5.000000000000e-03
- 555,5.700000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 556,5.700000000000e-01,1.950000000000e-01,5.000000000000e-03
- 557,5.750000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 558,5.750000000000e-01,1.950000000000e-01,5.000000000000e-03
- 559,5.800000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 560,5.800000000000e-01,1.950000000000e-01,5.000000000000e-03
- 561,5.850000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 562,5.850000000000e-01,1.950000000000e-01,5.000000000000e-03
- 563,5.900000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 564,5.900000000000e-01,1.950000000000e-01,5.000000000000e-03
- 565,5.950000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 566,5.950000000000e-01,1.950000000000e-01,5.000000000000e-03
- 567,6.000000000000e-01,1.950000000000e-01,-5.000000000000e-03
- 568,6.000000000000e-01,1.950000000000e-01,5.000000000000e-03
- 569,2.500000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 570,2.550000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 571,2.500000000000e-01,1.900000000000e-01,5.000000000000e-03
- 572,2.550000000000e-01,1.900000000000e-01,5.000000000000e-03
- 573,2.600000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 574,2.600000000000e-01,1.900000000000e-01,5.000000000000e-03
- 575,2.650000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 576,2.650000000000e-01,1.900000000000e-01,5.000000000000e-03
- 577,2.700000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 578,2.700000000000e-01,1.900000000000e-01,5.000000000000e-03
- 579,2.750000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 580,2.750000000000e-01,1.900000000000e-01,5.000000000000e-03
- 581,2.800000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 582,2.800000000000e-01,1.900000000000e-01,5.000000000000e-03
- 583,2.850000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 584,2.850000000000e-01,1.900000000000e-01,5.000000000000e-03
- 585,2.900000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 586,2.900000000000e-01,1.900000000000e-01,5.000000000000e-03
- 587,2.950000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 588,2.950000000000e-01,1.900000000000e-01,5.000000000000e-03
- 589,3.000000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 590,3.000000000000e-01,1.900000000000e-01,5.000000000000e-03
- 591,3.050000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 592,3.050000000000e-01,1.900000000000e-01,5.000000000000e-03
- 593,3.100000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 594,3.100000000000e-01,1.900000000000e-01,5.000000000000e-03
- 595,3.150000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 596,3.150000000000e-01,1.900000000000e-01,5.000000000000e-03
- 597,3.200000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 598,3.200000000000e-01,1.900000000000e-01,5.000000000000e-03
- 599,3.250000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 600,3.250000000000e-01,1.900000000000e-01,5.000000000000e-03
- 601,3.300000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 602,3.300000000000e-01,1.900000000000e-01,5.000000000000e-03
- 603,3.350000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 604,3.350000000000e-01,1.900000000000e-01,5.000000000000e-03
- 605,3.400000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 606,3.400000000000e-01,1.900000000000e-01,5.000000000000e-03
- 607,3.450000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 608,3.450000000000e-01,1.900000000000e-01,5.000000000000e-03
- 609,3.500000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 610,3.500000000000e-01,1.900000000000e-01,5.000000000000e-03
- 611,3.550000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 612,3.550000000000e-01,1.900000000000e-01,5.000000000000e-03
- 613,3.600000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 614,3.600000000000e-01,1.900000000000e-01,5.000000000000e-03
- 615,3.650000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 616,3.650000000000e-01,1.900000000000e-01,5.000000000000e-03
- 617,3.700000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 618,3.700000000000e-01,1.900000000000e-01,5.000000000000e-03
- 619,3.750000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 620,3.750000000000e-01,1.900000000000e-01,5.000000000000e-03
- 621,3.800000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 622,3.800000000000e-01,1.900000000000e-01,5.000000000000e-03
- 623,3.850000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 624,3.850000000000e-01,1.900000000000e-01,5.000000000000e-03
- 625,3.900000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 626,3.900000000000e-01,1.900000000000e-01,5.000000000000e-03
- 627,3.950000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 628,3.950000000000e-01,1.900000000000e-01,5.000000000000e-03
- 629,4.000000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 630,4.000000000000e-01,1.900000000000e-01,5.000000000000e-03
- 631,4.050000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 632,4.050000000000e-01,1.900000000000e-01,5.000000000000e-03
- 633,4.100000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 634,4.100000000000e-01,1.900000000000e-01,5.000000000000e-03
- 635,4.150000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 636,4.150000000000e-01,1.900000000000e-01,5.000000000000e-03
- 637,4.200000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 638,4.200000000000e-01,1.900000000000e-01,5.000000000000e-03
- 639,4.250000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 640,4.250000000000e-01,1.900000000000e-01,5.000000000000e-03
- 641,4.300000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 642,4.300000000000e-01,1.900000000000e-01,5.000000000000e-03
- 643,4.350000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 644,4.350000000000e-01,1.900000000000e-01,5.000000000000e-03
- 645,4.400000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 646,4.400000000000e-01,1.900000000000e-01,5.000000000000e-03
- 647,4.450000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 648,4.450000000000e-01,1.900000000000e-01,5.000000000000e-03
- 649,4.500000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 650,4.500000000000e-01,1.900000000000e-01,5.000000000000e-03
- 651,4.550000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 652,4.550000000000e-01,1.900000000000e-01,5.000000000000e-03
- 653,4.600000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 654,4.600000000000e-01,1.900000000000e-01,5.000000000000e-03
- 655,4.650000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 656,4.650000000000e-01,1.900000000000e-01,5.000000000000e-03
- 657,4.700000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 658,4.700000000000e-01,1.900000000000e-01,5.000000000000e-03
- 659,4.750000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 660,4.750000000000e-01,1.900000000000e-01,5.000000000000e-03
- 661,4.800000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 662,4.800000000000e-01,1.900000000000e-01,5.000000000000e-03
- 663,4.850000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 664,4.850000000000e-01,1.900000000000e-01,5.000000000000e-03
- 665,4.900000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 666,4.900000000000e-01,1.900000000000e-01,5.000000000000e-03
- 667,4.950000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 668,4.950000000000e-01,1.900000000000e-01,5.000000000000e-03
- 669,5.000000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 670,5.000000000000e-01,1.900000000000e-01,5.000000000000e-03
- 671,5.050000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 672,5.050000000000e-01,1.900000000000e-01,5.000000000000e-03
- 673,5.100000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 674,5.100000000000e-01,1.900000000000e-01,5.000000000000e-03
- 675,5.150000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 676,5.150000000000e-01,1.900000000000e-01,5.000000000000e-03
- 677,5.200000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 678,5.200000000000e-01,1.900000000000e-01,5.000000000000e-03
- 679,5.250000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 680,5.250000000000e-01,1.900000000000e-01,5.000000000000e-03
- 681,5.300000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 682,5.300000000000e-01,1.900000000000e-01,5.000000000000e-03
- 683,5.350000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 684,5.350000000000e-01,1.900000000000e-01,5.000000000000e-03
- 685,5.400000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 686,5.400000000000e-01,1.900000000000e-01,5.000000000000e-03
- 687,5.450000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 688,5.450000000000e-01,1.900000000000e-01,5.000000000000e-03
- 689,5.500000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 690,5.500000000000e-01,1.900000000000e-01,5.000000000000e-03
- 691,5.550000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 692,5.550000000000e-01,1.900000000000e-01,5.000000000000e-03
- 693,5.600000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 694,5.600000000000e-01,1.900000000000e-01,5.000000000000e-03
- 695,5.650000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 696,5.650000000000e-01,1.900000000000e-01,5.000000000000e-03
- 697,5.700000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 698,5.700000000000e-01,1.900000000000e-01,5.000000000000e-03
- 699,5.750000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 700,5.750000000000e-01,1.900000000000e-01,5.000000000000e-03
- 701,5.800000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 702,5.800000000000e-01,1.900000000000e-01,5.000000000000e-03
- 703,5.850000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 704,5.850000000000e-01,1.900000000000e-01,5.000000000000e-03
- 705,5.900000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 706,5.900000000000e-01,1.900000000000e-01,5.000000000000e-03
- 707,5.950000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 708,5.950000000000e-01,1.900000000000e-01,5.000000000000e-03
- 709,6.000000000000e-01,1.900000000000e-01,-5.000000000000e-03
- 710,6.000000000000e-01,1.900000000000e-01,5.000000000000e-03
-*ELEMENT, TYPE=C3D8, ELSET=Eall
- 1, 1, 2, 3, 4, 5, 6, 7, 8
- 2, 4, 3, 9, 10, 8, 7, 11, 12
- 3, 10, 9, 13, 14, 12, 11, 15, 16
- 4, 14, 13, 17, 18, 16, 15, 19, 20
- 5, 18, 17, 21, 22, 20, 19, 23, 24
- 6, 22, 21, 25, 26, 24, 23, 27, 28
- 7, 26, 25, 29, 30, 28, 27, 31, 32
- 8, 30, 29, 33, 34, 32, 31, 35, 36
- 9, 34, 33, 37, 38, 36, 35, 39, 40
- 10, 38, 37, 41, 42, 40, 39, 43, 44
- 11, 42, 41, 45, 46, 44, 43, 47, 48
- 12, 46, 45, 49, 50, 48, 47, 51, 52
- 13, 50, 49, 53, 54, 52, 51, 55, 56
- 14, 54, 53, 57, 58, 56, 55, 59, 60
- 15, 58, 57, 61, 62, 60, 59, 63, 64
- 16, 62, 61, 65, 66, 64, 63, 67, 68
- 17, 66, 65, 69, 70, 68, 67, 71, 72
- 18, 70, 69, 73, 74, 72, 71, 75, 76
- 19, 74, 73, 77, 78, 76, 75, 79, 80
- 20, 78, 77, 81, 82, 80, 79, 83, 84
- 21, 82, 81, 85, 86, 84, 83, 87, 88
- 22, 86, 85, 89, 90, 88, 87, 91, 92
- 23, 90, 89, 93, 94, 92, 91, 95, 96
- 24, 94, 93, 97, 98, 96, 95, 99, 100
- 25, 98, 97, 101, 102, 100, 99, 103, 104
- 26, 102, 101, 105, 106, 104, 103, 107, 108
- 27, 106, 105, 109, 110, 108, 107, 111, 112
- 28, 110, 109, 113, 114, 112, 111, 115, 116
- 29, 114, 113, 117, 118, 116, 115, 119, 120
- 30, 118, 117, 121, 122, 120, 119, 123, 124
- 31, 122, 121, 125, 126, 124, 123, 127, 128
- 32, 126, 125, 129, 130, 128, 127, 131, 132
- 33, 130, 129, 133, 134, 132, 131, 135, 136
- 34, 134, 133, 137, 138, 136, 135, 139, 140
- 35, 138, 137, 141, 142, 140, 139, 143, 144
- 36, 142, 141, 145, 146, 144, 143, 147, 148
- 37, 146, 145, 149, 150, 148, 147, 151, 152
- 38, 150, 149, 153, 154, 152, 151, 155, 156
- 39, 154, 153, 157, 158, 156, 155, 159, 160
- 40, 158, 157, 161, 162, 160, 159, 163, 164
- 41, 162, 161, 165, 166, 164, 163, 167, 168
- 42, 166, 165, 169, 170, 168, 167, 171, 172
- 43, 170, 169, 173, 174, 172, 171, 175, 176
- 44, 174, 173, 177, 178, 176, 175, 179, 180
- 45, 178, 177, 181, 182, 180, 179, 183, 184
- 46, 182, 181, 185, 186, 184, 183, 187, 188
- 47, 186, 185, 189, 190, 188, 187, 191, 192
- 48, 190, 189, 193, 194, 192, 191, 195, 196
- 49, 194, 193, 197, 198, 196, 195, 199, 200
- 50, 198, 197, 201, 202, 200, 199, 203, 204
- 51, 202, 201, 205, 206, 204, 203, 207, 208
- 52, 206, 205, 209, 210, 208, 207, 211, 212
- 53, 210, 209, 213, 214, 212, 211, 215, 216
- 54, 214, 213, 217, 218, 216, 215, 219, 220
- 55, 218, 217, 221, 222, 220, 219, 223, 224
- 56, 222, 221, 225, 226, 224, 223, 227, 228
- 57, 226, 225, 229, 230, 228, 227, 231, 232
- 58, 230, 229, 233, 234, 232, 231, 235, 236
- 59, 234, 233, 237, 238, 236, 235, 239, 240
- 60, 238, 237, 241, 242, 240, 239, 243, 244
- 61, 242, 241, 245, 246, 244, 243, 247, 248
- 62, 246, 245, 249, 250, 248, 247, 251, 252
- 63, 250, 249, 253, 254, 252, 251, 255, 256
- 64, 254, 253, 257, 258, 256, 255, 259, 260
- 65, 258, 257, 261, 262, 260, 259, 263, 264
- 66, 262, 261, 265, 266, 264, 263, 267, 268
- 67, 266, 265, 269, 270, 268, 267, 271, 272
- 68, 270, 269, 273, 274, 272, 271, 275, 276
- 69, 274, 273, 277, 278, 276, 275, 279, 280
- 70, 278, 277, 281, 282, 280, 279, 283, 284
- 71, 2, 285, 286, 3, 6, 287, 288, 7
- 72, 3, 286, 289, 9, 7, 288, 290, 11
- 73, 9, 289, 291, 13, 11, 290, 292, 15
- 74, 13, 291, 293, 17, 15, 292, 294, 19
- 75, 17, 293, 295, 21, 19, 294, 296, 23
- 76, 21, 295, 297, 25, 23, 296, 298, 27
- 77, 25, 297, 299, 29, 27, 298, 300, 31
- 78, 29, 299, 301, 33, 31, 300, 302, 35
- 79, 33, 301, 303, 37, 35, 302, 304, 39
- 80, 37, 303, 305, 41, 39, 304, 306, 43
- 81, 41, 305, 307, 45, 43, 306, 308, 47
- 82, 45, 307, 309, 49, 47, 308, 310, 51
- 83, 49, 309, 311, 53, 51, 310, 312, 55
- 84, 53, 311, 313, 57, 55, 312, 314, 59
- 85, 57, 313, 315, 61, 59, 314, 316, 63
- 86, 61, 315, 317, 65, 63, 316, 318, 67
- 87, 65, 317, 319, 69, 67, 318, 320, 71
- 88, 69, 319, 321, 73, 71, 320, 322, 75
- 89, 73, 321, 323, 77, 75, 322, 324, 79
- 90, 77, 323, 325, 81, 79, 324, 326, 83
- 91, 81, 325, 327, 85, 83, 326, 328, 87
- 92, 85, 327, 329, 89, 87, 328, 330, 91
- 93, 89, 329, 331, 93, 91, 330, 332, 95
- 94, 93, 331, 333, 97, 95, 332, 334, 99
- 95, 97, 333, 335, 101, 99, 334, 336, 103
- 96, 101, 335, 337, 105, 103, 336, 338, 107
- 97, 105, 337, 339, 109, 107, 338, 340, 111
- 98, 109, 339, 341, 113, 111, 340, 342, 115
- 99, 113, 341, 343, 117, 115, 342, 344, 119
- 100, 117, 343, 345, 121, 119, 344, 346, 123
- 101, 121, 345, 347, 125, 123, 346, 348, 127
- 102, 125, 347, 349, 129, 127, 348, 350, 131
- 103, 129, 349, 351, 133, 131, 350, 352, 135
- 104, 133, 351, 353, 137, 135, 352, 354, 139
- 105, 137, 353, 355, 141, 139, 354, 356, 143
- 106, 141, 355, 357, 145, 143, 356, 358, 147
- 107, 145, 357, 359, 149, 147, 358, 360, 151
- 108, 149, 359, 361, 153, 151, 360, 362, 155
- 109, 153, 361, 363, 157, 155, 362, 364, 159
- 110, 157, 363, 365, 161, 159, 364, 366, 163
- 111, 161, 365, 367, 165, 163, 366, 368, 167
- 112, 165, 367, 369, 169, 167, 368, 370, 171
- 113, 169, 369, 371, 173, 171, 370, 372, 175
- 114, 173, 371, 373, 177, 175, 372, 374, 179
- 115, 177, 373, 375, 181, 179, 374, 376, 183
- 116, 181, 375, 377, 185, 183, 376, 378, 187
- 117, 185, 377, 379, 189, 187, 378, 380, 191
- 118, 189, 379, 381, 193, 191, 380, 382, 195
- 119, 193, 381, 383, 197, 195, 382, 384, 199
- 120, 197, 383, 385, 201, 199, 384, 386, 203
- 121, 201, 385, 387, 205, 203, 386, 388, 207
- 122, 205, 387, 389, 209, 207, 388, 390, 211
- 123, 209, 389, 391, 213, 211, 390, 392, 215
- 124, 213, 391, 393, 217, 215, 392, 394, 219
- 125, 217, 393, 395, 221, 219, 394, 396, 223
- 126, 221, 395, 397, 225, 223, 396, 398, 227
- 127, 225, 397, 399, 229, 227, 398, 400, 231
- 128, 229, 399, 401, 233, 231, 400, 402, 235
- 129, 233, 401, 403, 237, 235, 402, 404, 239
- 130, 237, 403, 405, 241, 239, 404, 406, 243
- 131, 241, 405, 407, 245, 243, 406, 408, 247
- 132, 245, 407, 409, 249, 247, 408, 410, 251
- 133, 249, 409, 411, 253, 251, 410, 412, 255
- 134, 253, 411, 413, 257, 255, 412, 414, 259
- 135, 257, 413, 415, 261, 259, 414, 416, 263
- 136, 261, 415, 417, 265, 263, 416, 418, 267
- 137, 265, 417, 419, 269, 267, 418, 420, 271
- 138, 269, 419, 421, 273, 271, 420, 422, 275
- 139, 273, 421, 423, 277, 275, 422, 424, 279
- 140, 277, 423, 425, 281, 279, 424, 426, 283
- 141, 285, 427, 428, 286, 287, 429, 430, 288
- 142, 286, 428, 431, 289, 288, 430, 432, 290
- 143, 289, 431, 433, 291, 290, 432, 434, 292
- 144, 291, 433, 435, 293, 292, 434, 436, 294
- 145, 293, 435, 437, 295, 294, 436, 438, 296
- 146, 295, 437, 439, 297, 296, 438, 440, 298
- 147, 297, 439, 441, 299, 298, 440, 442, 300
- 148, 299, 441, 443, 301, 300, 442, 444, 302
- 149, 301, 443, 445, 303, 302, 444, 446, 304
- 150, 303, 445, 447, 305, 304, 446, 448, 306
- 151, 305, 447, 449, 307, 306, 448, 450, 308
- 152, 307, 449, 451, 309, 308, 450, 452, 310
- 153, 309, 451, 453, 311, 310, 452, 454, 312
- 154, 311, 453, 455, 313, 312, 454, 456, 314
- 155, 313, 455, 457, 315, 314, 456, 458, 316
- 156, 315, 457, 459, 317, 316, 458, 460, 318
- 157, 317, 459, 461, 319, 318, 460, 462, 320
- 158, 319, 461, 463, 321, 320, 462, 464, 322
- 159, 321, 463, 465, 323, 322, 464, 466, 324
- 160, 323, 465, 467, 325, 324, 466, 468, 326
- 161, 325, 467, 469, 327, 326, 468, 470, 328
- 162, 327, 469, 471, 329, 328, 470, 472, 330
- 163, 329, 471, 473, 331, 330, 472, 474, 332
- 164, 331, 473, 475, 333, 332, 474, 476, 334
- 165, 333, 475, 477, 335, 334, 476, 478, 336
- 166, 335, 477, 479, 337, 336, 478, 480, 338
- 167, 337, 479, 481, 339, 338, 480, 482, 340
- 168, 339, 481, 483, 341, 340, 482, 484, 342
- 169, 341, 483, 485, 343, 342, 484, 486, 344
- 170, 343, 485, 487, 345, 344, 486, 488, 346
- 171, 345, 487, 489, 347, 346, 488, 490, 348
- 172, 347, 489, 491, 349, 348, 490, 492, 350
- 173, 349, 491, 493, 351, 350, 492, 494, 352
- 174, 351, 493, 495, 353, 352, 494, 496, 354
- 175, 353, 495, 497, 355, 354, 496, 498, 356
- 176, 355, 497, 499, 357, 356, 498, 500, 358
- 177, 357, 499, 501, 359, 358, 500, 502, 360
- 178, 359, 501, 503, 361, 360, 502, 504, 362
- 179, 361, 503, 505, 363, 362, 504, 506, 364
- 180, 363, 505, 507, 365, 364, 506, 508, 366
- 181, 365, 507, 509, 367, 366, 508, 510, 368
- 182, 367, 509, 511, 369, 368, 510, 512, 370
- 183, 369, 511, 513, 371, 370, 512, 514, 372
- 184, 371, 513, 515, 373, 372, 514, 516, 374
- 185, 373, 515, 517, 375, 374, 516, 518, 376
- 186, 375, 517, 519, 377, 376, 518, 520, 378
- 187, 377, 519, 521, 379, 378, 520, 522, 380
- 188, 379, 521, 523, 381, 380, 522, 524, 382
- 189, 381, 523, 525, 383, 382, 524, 526, 384
- 190, 383, 525, 527, 385, 384, 526, 528, 386
- 191, 385, 527, 529, 387, 386, 528, 530, 388
- 192, 387, 529, 531, 389, 388, 530, 532, 390
- 193, 389, 531, 533, 391, 390, 532, 534, 392
- 194, 391, 533, 535, 393, 392, 534, 536, 394
- 195, 393, 535, 537, 395, 394, 536, 538, 396
- 196, 395, 537, 539, 397, 396, 538, 540, 398
- 197, 397, 539, 541, 399, 398, 540, 542, 400
- 198, 399, 541, 543, 401, 400, 542, 544, 402
- 199, 401, 543, 545, 403, 402, 544, 546, 404
- 200, 403, 545, 547, 405, 404, 546, 548, 406
- 201, 405, 547, 549, 407, 406, 548, 550, 408
- 202, 407, 549, 551, 409, 408, 550, 552, 410
- 203, 409, 551, 553, 411, 410, 552, 554, 412
- 204, 411, 553, 555, 413, 412, 554, 556, 414
- 205, 413, 555, 557, 415, 414, 556, 558, 416
- 206, 415, 557, 559, 417, 416, 558, 560, 418
- 207, 417, 559, 561, 419, 418, 560, 562, 420
- 208, 419, 561, 563, 421, 420, 562, 564, 422
- 209, 421, 563, 565, 423, 422, 564, 566, 424
- 210, 423, 565, 567, 425, 424, 566, 568, 426
- 211, 427, 569, 570, 428, 429, 571, 572, 430
- 212, 428, 570, 573, 431, 430, 572, 574, 432
- 213, 431, 573, 575, 433, 432, 574, 576, 434
- 214, 433, 575, 577, 435, 434, 576, 578, 436
- 215, 435, 577, 579, 437, 436, 578, 580, 438
- 216, 437, 579, 581, 439, 438, 580, 582, 440
- 217, 439, 581, 583, 441, 440, 582, 584, 442
- 218, 441, 583, 585, 443, 442, 584, 586, 444
- 219, 443, 585, 587, 445, 444, 586, 588, 446
- 220, 445, 587, 589, 447, 446, 588, 590, 448
- 221, 447, 589, 591, 449, 448, 590, 592, 450
- 222, 449, 591, 593, 451, 450, 592, 594, 452
- 223, 451, 593, 595, 453, 452, 594, 596, 454
- 224, 453, 595, 597, 455, 454, 596, 598, 456
- 225, 455, 597, 599, 457, 456, 598, 600, 458
- 226, 457, 599, 601, 459, 458, 600, 602, 460
- 227, 459, 601, 603, 461, 460, 602, 604, 462
- 228, 461, 603, 605, 463, 462, 604, 606, 464
- 229, 463, 605, 607, 465, 464, 606, 608, 466
- 230, 465, 607, 609, 467, 466, 608, 610, 468
- 231, 467, 609, 611, 469, 468, 610, 612, 470
- 232, 469, 611, 613, 471, 470, 612, 614, 472
- 233, 471, 613, 615, 473, 472, 614, 616, 474
- 234, 473, 615, 617, 475, 474, 616, 618, 476
- 235, 475, 617, 619, 477, 476, 618, 620, 478
- 236, 477, 619, 621, 479, 478, 620, 622, 480
- 237, 479, 621, 623, 481, 480, 622, 624, 482
- 238, 481, 623, 625, 483, 482, 624, 626, 484
- 239, 483, 625, 627, 485, 484, 626, 628, 486
- 240, 485, 627, 629, 487, 486, 628, 630, 488
- 241, 487, 629, 631, 489, 488, 630, 632, 490
- 242, 489, 631, 633, 491, 490, 632, 634, 492
- 243, 491, 633, 635, 493, 492, 634, 636, 494
- 244, 493, 635, 637, 495, 494, 636, 638, 496
- 245, 495, 637, 639, 497, 496, 638, 640, 498
- 246, 497, 639, 641, 499, 498, 640, 642, 500
- 247, 499, 641, 643, 501, 500, 642, 644, 502
- 248, 501, 643, 645, 503, 502, 644, 646, 504
- 249, 503, 645, 647, 505, 504, 646, 648, 506
- 250, 505, 647, 649, 507, 506, 648, 650, 508
- 251, 507, 649, 651, 509, 508, 650, 652, 510
- 252, 509, 651, 653, 511, 510, 652, 654, 512
- 253, 511, 653, 655, 513, 512, 654, 656, 514
- 254, 513, 655, 657, 515, 514, 656, 658, 516
- 255, 515, 657, 659, 517, 516, 658, 660, 518
- 256, 517, 659, 661, 519, 518, 660, 662, 520
- 257, 519, 661, 663, 521, 520, 662, 664, 522
- 258, 521, 663, 665, 523, 522, 664, 666, 524
- 259, 523, 665, 667, 525, 524, 666, 668, 526
- 260, 525, 667, 669, 527, 526, 668, 670, 528
- 261, 527, 669, 671, 529, 528, 670, 672, 530
- 262, 529, 671, 673, 531, 530, 672, 674, 532
- 263, 531, 673, 675, 533, 532, 674, 676, 534
- 264, 533, 675, 677, 535, 534, 676, 678, 536
- 265, 535, 677, 679, 537, 536, 678, 680, 538
- 266, 537, 679, 681, 539, 538, 680, 682, 540
- 267, 539, 681, 683, 541, 540, 682, 684, 542
- 268, 541, 683, 685, 543, 542, 684, 686, 544
- 269, 543, 685, 687, 545, 544, 686, 688, 546
- 270, 545, 687, 689, 547, 546, 688, 690, 548
- 271, 547, 689, 691, 549, 548, 690, 692, 550
- 272, 549, 691, 693, 551, 550, 692, 694, 552
- 273, 551, 693, 695, 553, 552, 694, 696, 554
- 274, 553, 695, 697, 555, 554, 696, 698, 556
- 275, 555, 697, 699, 557, 556, 698, 700, 558
- 276, 557, 699, 701, 559, 558, 700, 702, 560
- 277, 559, 701, 703, 561, 560, 702, 704, 562
- 278, 561, 703, 705, 563, 562, 704, 706, 564
- 279, 563, 705, 707, 565, 564, 706, 708, 566
- 280, 565, 707, 709, 567, 566, 708, 710, 568
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/fix1.nam b/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/fix1.nam
deleted file mode 100644
index d2ed0afea..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/fix1.nam
+++ /dev/null
@@ -1,12 +0,0 @@
-** Names based on fix1
-*NSET,NSET=Nfix1
-1,
-2,
-5,
-6,
-285,
-287,
-427,
-429,
-569,
-571,
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/flap.inp b/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/flap.inp
deleted file mode 100644
index 3a7601faa..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/flap.inp
+++ /dev/null
@@ -1,32 +0,0 @@
-*INCLUDE, INPUT=Solid/all.msh
-*INCLUDE, INPUT=Solid/fix1.nam
-*INCLUDE, INPUT=Solid/surface.nam
-*INCLUDE, INPUT=Solid/add_material.inp
-**------------------------------
-** additional support for sides
-**------------------------------
-
-*STEP, NLGEOM, INC=10000000
-*DYNAMIC,DIRECT
-1.E-3, 100.0
-
-*BOUNDARY
-Nall, 3, 5
-
-** fix on the lower boundary from x to z.
-*BOUNDARY
-Nfix1, 1, 6
-** fix on all nodes for translation in z-dir, rotation about x- and y-axis
-*BOUNDARY
-Nall, 3, 3, 0
-Nall, 4, 4, 0
-Nall, 5, 5, 0
-*CLOAD
- Nsurface, 1, 0.0
- Nsurface, 2, 0.0
- Nsurface, 3, 0.0
-*NODE FILE
- U, RF
-*EL FILE
- S, E
-*END STEP
\ No newline at end of file
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/post_flap.fbd b/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/post_flap.fbd
deleted file mode 100644
index 55c60ab9a..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/post_flap.fbd
+++ /dev/null
@@ -1,20 +0,0 @@
-ulin cylinder with flap parallel to the flow
-read Solid/flap.frd
-read Solid/flap.inp
-view elem
-view disp
-rot -z
-ds 1 e 4
-#graph NA time DISP D1
-#q
-#graph NA time DISP D2
-#q
-#quit
-
-anim real
-# movi frames auto
-ds 2 ah 7
-# min 0
-# max 2.5e10
-#sys mv movie.gif figures/displacement.gif
-# quit
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/pre_flap.fbd b/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/pre_flap.fbd
deleted file mode 100644
index d8a173700..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/pre_flap.fbd
+++ /dev/null
@@ -1,48 +0,0 @@
-#!/bin/bash
-#For the beam elements
-valu c 0.35
-valu h 0.02
-valu dz 1.
-valu nd 0.005
-
-pnt p1 0.25 0.19 -0.005
-pnt p2 0.25 0.19 0.005
-line l1 p1 p2 1
-seta fix1 all
-swep fix1 fix1 tra 0 h 0 1
-seta fix1 all
-comp fix1 do
-
-swep all flap tra c 0 0 1
-seta surface s A002 A003 A004
-comp surface do
-
-
-seta length l L00A L00B L008 L009
-seta width l L002 L003 L006 L007
-
-div length auto nd
-div width auto nd
-elty all he8
-mesh all
-
-send all abq
-send fix1 abq nam
-send surface abq nam
-
-view elem
-# #rot z
-#rot r 50
-#rot u 50
-
-plot f all
-
-#sys mv surface.nam interface_beam.nam
-#sys mv fix1.nam fix1_beam.nam
-
-# Add thing here for the boundary condition
-# sys echo
-# quit
-
-# plus la all
-# plus pa all
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/config.yml b/FSI/cylinderFlap/OpenFOAM-CalculiX/config.yml
deleted file mode 100644
index c7b79b631..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/config.yml
+++ /dev/null
@@ -1,10 +0,0 @@
-participants:
-
- Calculix:
- interfaces:
- - nodes-mesh: Calculix_Mesh
- patch: surface
- read-data: [Forces0]
- write-data: [Displacements0]
-
-precice-config-file: ./precice-config.xml
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/plotDisplacement.sh b/FSI/cylinderFlap/OpenFOAM-CalculiX/plotDisplacement.sh
deleted file mode 100755
index d589f15d2..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/plotDisplacement.sh
+++ /dev/null
@@ -1,9 +0,0 @@
-#! /bin/bash
-gnuplot -p << EOF
-set grid
-set title 'Displacement of the Flap Tip'
-set xlabel 'Time [s]'
-set ylabel 'Y-Displacement [m]'
-plot "precice-Calculix-watchpoint-point1.log" using 1:9 with lines title ""
-EOF
-
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/precice-config.xml b/FSI/cylinderFlap/OpenFOAM-CalculiX/precice-config.xml
deleted file mode 100644
index 866b1bff3..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/precice-config.xml
+++ /dev/null
@@ -1,72 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/removeObsoleteFolders.sh b/FSI/cylinderFlap/OpenFOAM-CalculiX/removeObsoleteFolders.sh
deleted file mode 100755
index 80288fe27..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,23 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
-
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/runFluid b/FSI/cylinderFlap/OpenFOAM-CalculiX/runFluid
deleted file mode 100755
index 62cc3a5e9..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/runFluid
+++ /dev/null
@@ -1,45 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the "runSolid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- solver=$(getApplication)
- nprocs=$(getNumberOfProcessors)
-cd ..
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $nprocs $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26
-./removeObsoleteFolders.sh
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/runSolid b/FSI/cylinderFlap/OpenFOAM-CalculiX/runSolid
deleted file mode 100755
index d4bcfe976..000000000
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/runSolid
+++ /dev/null
@@ -1,14 +0,0 @@
-#!/bin/bash
-
-# Solid participant
-
-# Run this script in one terminal and the "runFluid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# The script "Allclean" cleans-up the result and log files.
-
-echo "Running the Solid participant..."
-
-# Run
-ccx_preCICE -i Solid/flap -precice-participant Calculix
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Allclean b/FSI/cylinderFlap/OpenFOAM-deal.II/Allclean
deleted file mode 100755
index cba35d382..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Allclean
+++ /dev/null
@@ -1,55 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid (OpenFOAM)
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- rm -rfv 0
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid (deal.II)
-Participant2="Solid"
-cd ./Solid/dealii_output
- # Clean the case
- echo "Cleaning Solid case"
- rm -fv solution-*.vtk
-cd ..
- rm -fv solution-*.vtk
-cd ..
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Allrun b/FSI/cylinderFlap/OpenFOAM-deal.II/Allrun
deleted file mode 100755
index e6bc2e9dc..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Allrun
+++ /dev/null
@@ -1,107 +0,0 @@
-#!/bin/bash
-
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the script "runFluid" and start the Solid participant manually
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- echo " Restoring 0/ from 0.orig/..."
- rm -rfv 0
- cp -r 0.orig 0
- cd ..
-
- echo " Preparing the mesh..."
- blockMesh -case ${Participant1} > ${Participant1}_blockMesh.log 2>&1
- checkMesh -case ${Participant1} > ${Participant1}_checkMesh.log 2>&1
-
- # get application information
- cd ${Participant1}
- Solver1=$(getApplication) # solver
- echo " ${Participant1} Solver: ${Solver1}."
- cd ..
-
- # Run and get the process id
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-Solver2="nonlinear_elasticity"
-
- # Run
- echo " Starting the ${Participant2} participant..."
- ./runSolid -nonlinear > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
- if [ $parallel -eq 1 ]; then
- echo "Reconstructing fields..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1 &
- fi
-
- # Workaround for issue #26
- echo "Problems with time directories without results? Run the script removeObsoleteFolders.sh and see issue #26 on GitHub."
- # ./removeObsoleteFolders.sh
-
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/U b/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/U
deleted file mode 100644
index d5a072d6e..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/U
+++ /dev/null
@@ -1,65 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
-
- cylinder
- {
- type noSlip;
- }
-
- flap
- {
- type movingWallVelocity;
- value uniform (0 0 0);
- }
-
- top
- {
- type noSlip;
- }
-
- bottom
- {
- type noSlip;
- }
-
- inlet
- {
- // Time-varying inlet velocity
- type uniformFixedValue;
- uniformValue table
- (
- ( 0 ( 0 0 0 ) )
- ( 2. ( 2. 0 0 ) )
- ( 100 ( 2. 0 0 ) )
- );
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/p b/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/p
deleted file mode 100644
index 52e0fdef3..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/p
+++ /dev/null
@@ -1,57 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 2 -2 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- cylinder
- {
- type zeroGradient;
- }
-
- flap
- {
- type zeroGradient;
- }
-
- top
- {
- type zeroGradient;
- }
-
- bottom
- {
- type zeroGradient;
- }
-
- inlet
- {
- type zeroGradient;
- }
-
- outlet
- {
- type fixedValue;
- value uniform 0;
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/Fluid.foam b/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/controlDict b/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/controlDict
deleted file mode 100644
index 6432a10d4..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/controlDict
+++ /dev/null
@@ -1,49 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location system;
- object controlDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-// Note: With OpenFOAM v1806 and OpenFOAM 6, the DyM solvers
-// were marked deprecated and merged into their respective standard solvers.
-application pimpleFoam; // OpenFOAM v1806, OpenFOAM 6, or newer
-// application pimpleDyMFoam; // OpenFOAM v1712, OpenFOAM 5.x, or older
-
-startFrom startTime;
-
-startTime 0;
-
-stopAt endTime;
-
-endTime 15;
-
-deltaT 0.002;
-
-writeControl adjustableRunTime;
-
-writeInterval 100;
-
-purgeWrite 0;
-
-writeFormat ascii;
-
-writePrecision 10;
-
-writeCompression off;
-
-timeFormat general;
-
-timePrecision 12;
-
-functions
-{
- preCICE_Adapter
- {
- type preciceAdapterFunctionObject;
- libs ("libpreciceAdapterFunctionObject.so");
- }
-}
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/decomposeParDict b/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/decomposeParDict
deleted file mode 100644
index c72a5d50e..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/decomposeParDict
+++ /dev/null
@@ -1,25 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location system;
- object decomposeParDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- numberOfSubdomains 6;
-
- method hierarchical;
- hierarchicalCoeffs
- {
- n (3 2 1);
- delta 0.001;
- order xyz;
- }
-
- distributed false;
- roots
- (
- );
-
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/README.md b/FSI/cylinderFlap/OpenFOAM-deal.II/README.md
deleted file mode 100644
index 08eccd3f7..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/README.md
+++ /dev/null
@@ -1,20 +0,0 @@
-# Tutorial for an FSI simulation of a cylinder-flap scenario
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM). Have also a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-You may run the coupled simulation in serial using the script `Allrun` or (OpenFOAM) in parallel with `Allrun -parallel`. The output of each step will be redirected to log files. You can cleanup the simulation using `Allclean`.
-
-If you prefer to run the two simulations in two different terminals and watch their output on the screen, use the (simpler) scripts `runFluid` (or `runFluid -parallel`).
-
-Before starting the deal.II program, it needs to be compiled and copied in this case directory. Information about building is collected in the [deal.II wiki](https://github.com/precice/dealii-adapter/wiki/Building). You can use the following command to run e.g. the nonlinear deal.II solver afterwards:
-```
-./runSolid -nonlinear
-```
-
-There is an [open issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. Please run the script `removeObsoleteSolvers.sh` to delete the additional files.
-
-You may adjust the end time in the precice-config_*.xml, or interupt the execution earlier if you want.
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/dealii_output/initial_grid.vtk b/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/dealii_output/initial_grid.vtk
deleted file mode 100644
index 7123eded1..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/dealii_output/initial_grid.vtk
+++ /dev/null
@@ -1,2590 +0,0 @@
-# vtk DataFile Version 3.0
-#This file was generated by the deal.II library on 2019/6/13 at 19:12:39
-ASCII
-DATASET UNSTRUCTURED_GRID
-
-POINTS 1200 double
-0.24899 0.19 -0.005
-0.26069 0.19 -0.005
-0.24899 0.194 -0.005
-0.26069 0.194 -0.005
-0.24899 0.19 0.005
-0.26069 0.19 0.005
-0.24899 0.194 0.005
-0.26069 0.194 0.005
-0.26069 0.19 -0.005
-0.272391 0.19 -0.005
-0.26069 0.194 -0.005
-0.272391 0.194 -0.005
-0.26069 0.19 0.005
-0.272391 0.19 0.005
-0.26069 0.194 0.005
-0.272391 0.194 0.005
-0.272391 0.19 -0.005
-0.284091 0.19 -0.005
-0.272391 0.194 -0.005
-0.284091 0.194 -0.005
-0.272391 0.19 0.005
-0.284091 0.19 0.005
-0.272391 0.194 0.005
-0.284091 0.194 0.005
-0.284091 0.19 -0.005
-0.295791 0.19 -0.005
-0.284091 0.194 -0.005
-0.295791 0.194 -0.005
-0.284091 0.19 0.005
-0.295791 0.19 0.005
-0.284091 0.194 0.005
-0.295791 0.194 0.005
-0.295791 0.19 -0.005
-0.307492 0.19 -0.005
-0.295791 0.194 -0.005
-0.307492 0.194 -0.005
-0.295791 0.19 0.005
-0.307492 0.19 0.005
-0.295791 0.194 0.005
-0.307492 0.194 0.005
-0.307492 0.19 -0.005
-0.319192 0.19 -0.005
-0.307492 0.194 -0.005
-0.319192 0.194 -0.005
-0.307492 0.19 0.005
-0.319192 0.19 0.005
-0.307492 0.194 0.005
-0.319192 0.194 0.005
-0.319192 0.19 -0.005
-0.330892 0.19 -0.005
-0.319192 0.194 -0.005
-0.330892 0.194 -0.005
-0.319192 0.19 0.005
-0.330892 0.19 0.005
-0.319192 0.194 0.005
-0.330892 0.194 0.005
-0.330892 0.19 -0.005
-0.342593 0.19 -0.005
-0.330892 0.194 -0.005
-0.342593 0.194 -0.005
-0.330892 0.19 0.005
-0.342593 0.19 0.005
-0.330892 0.194 0.005
-0.342593 0.194 0.005
-0.342593 0.19 -0.005
-0.354293 0.19 -0.005
-0.342593 0.194 -0.005
-0.354293 0.194 -0.005
-0.342593 0.19 0.005
-0.354293 0.19 0.005
-0.342593 0.194 0.005
-0.354293 0.194 0.005
-0.354293 0.19 -0.005
-0.365993 0.19 -0.005
-0.354293 0.194 -0.005
-0.365993 0.194 -0.005
-0.354293 0.19 0.005
-0.365993 0.19 0.005
-0.354293 0.194 0.005
-0.365993 0.194 0.005
-0.365993 0.19 -0.005
-0.377694 0.19 -0.005
-0.365993 0.194 -0.005
-0.377694 0.194 -0.005
-0.365993 0.19 0.005
-0.377694 0.19 0.005
-0.365993 0.194 0.005
-0.377694 0.194 0.005
-0.377694 0.19 -0.005
-0.389394 0.19 -0.005
-0.377694 0.194 -0.005
-0.389394 0.194 -0.005
-0.377694 0.19 0.005
-0.389394 0.19 0.005
-0.377694 0.194 0.005
-0.389394 0.194 0.005
-0.389394 0.19 -0.005
-0.401094 0.19 -0.005
-0.389394 0.194 -0.005
-0.401094 0.194 -0.005
-0.389394 0.19 0.005
-0.401094 0.19 0.005
-0.389394 0.194 0.005
-0.401094 0.194 0.005
-0.401094 0.19 -0.005
-0.412795 0.19 -0.005
-0.401094 0.194 -0.005
-0.412795 0.194 -0.005
-0.401094 0.19 0.005
-0.412795 0.19 0.005
-0.401094 0.194 0.005
-0.412795 0.194 0.005
-0.412795 0.19 -0.005
-0.424495 0.19 -0.005
-0.412795 0.194 -0.005
-0.424495 0.194 -0.005
-0.412795 0.19 0.005
-0.424495 0.19 0.005
-0.412795 0.194 0.005
-0.424495 0.194 0.005
-0.424495 0.19 -0.005
-0.436195 0.19 -0.005
-0.424495 0.194 -0.005
-0.436195 0.194 -0.005
-0.424495 0.19 0.005
-0.436195 0.19 0.005
-0.424495 0.194 0.005
-0.436195 0.194 0.005
-0.436195 0.19 -0.005
-0.447896 0.19 -0.005
-0.436195 0.194 -0.005
-0.447896 0.194 -0.005
-0.436195 0.19 0.005
-0.447896 0.19 0.005
-0.436195 0.194 0.005
-0.447896 0.194 0.005
-0.447896 0.19 -0.005
-0.459596 0.19 -0.005
-0.447896 0.194 -0.005
-0.459596 0.194 -0.005
-0.447896 0.19 0.005
-0.459596 0.19 0.005
-0.447896 0.194 0.005
-0.459596 0.194 0.005
-0.459596 0.19 -0.005
-0.471296 0.19 -0.005
-0.459596 0.194 -0.005
-0.471296 0.194 -0.005
-0.459596 0.19 0.005
-0.471296 0.19 0.005
-0.459596 0.194 0.005
-0.471296 0.194 0.005
-0.471296 0.19 -0.005
-0.482997 0.19 -0.005
-0.471296 0.194 -0.005
-0.482997 0.194 -0.005
-0.471296 0.19 0.005
-0.482997 0.19 0.005
-0.471296 0.194 0.005
-0.482997 0.194 0.005
-0.482997 0.19 -0.005
-0.494697 0.19 -0.005
-0.482997 0.194 -0.005
-0.494697 0.194 -0.005
-0.482997 0.19 0.005
-0.494697 0.19 0.005
-0.482997 0.194 0.005
-0.494697 0.194 0.005
-0.494697 0.19 -0.005
-0.506397 0.19 -0.005
-0.494697 0.194 -0.005
-0.506397 0.194 -0.005
-0.494697 0.19 0.005
-0.506397 0.19 0.005
-0.494697 0.194 0.005
-0.506397 0.194 0.005
-0.506397 0.19 -0.005
-0.518098 0.19 -0.005
-0.506397 0.194 -0.005
-0.518098 0.194 -0.005
-0.506397 0.19 0.005
-0.518098 0.19 0.005
-0.506397 0.194 0.005
-0.518098 0.194 0.005
-0.518098 0.19 -0.005
-0.529798 0.19 -0.005
-0.518098 0.194 -0.005
-0.529798 0.194 -0.005
-0.518098 0.19 0.005
-0.529798 0.19 0.005
-0.518098 0.194 0.005
-0.529798 0.194 0.005
-0.529798 0.19 -0.005
-0.541498 0.19 -0.005
-0.529798 0.194 -0.005
-0.541498 0.194 -0.005
-0.529798 0.19 0.005
-0.541498 0.19 0.005
-0.529798 0.194 0.005
-0.541498 0.194 0.005
-0.541498 0.19 -0.005
-0.553199 0.19 -0.005
-0.541498 0.194 -0.005
-0.553199 0.194 -0.005
-0.541498 0.19 0.005
-0.553199 0.19 0.005
-0.541498 0.194 0.005
-0.553199 0.194 0.005
-0.553199 0.19 -0.005
-0.564899 0.19 -0.005
-0.553199 0.194 -0.005
-0.564899 0.194 -0.005
-0.553199 0.19 0.005
-0.564899 0.19 0.005
-0.553199 0.194 0.005
-0.564899 0.194 0.005
-0.564899 0.19 -0.005
-0.576599 0.19 -0.005
-0.564899 0.194 -0.005
-0.576599 0.194 -0.005
-0.564899 0.19 0.005
-0.576599 0.19 0.005
-0.564899 0.194 0.005
-0.576599 0.194 0.005
-0.576599 0.19 -0.005
-0.5883 0.19 -0.005
-0.576599 0.194 -0.005
-0.5883 0.194 -0.005
-0.576599 0.19 0.005
-0.5883 0.19 0.005
-0.576599 0.194 0.005
-0.5883 0.194 0.005
-0.5883 0.19 -0.005
-0.6 0.19 -0.005
-0.5883 0.194 -0.005
-0.6 0.194 -0.005
-0.5883 0.19 0.005
-0.6 0.19 0.005
-0.5883 0.194 0.005
-0.6 0.194 0.005
-0.24899 0.194 -0.005
-0.26069 0.194 -0.005
-0.24899 0.198 -0.005
-0.26069 0.198 -0.005
-0.24899 0.194 0.005
-0.26069 0.194 0.005
-0.24899 0.198 0.005
-0.26069 0.198 0.005
-0.26069 0.194 -0.005
-0.272391 0.194 -0.005
-0.26069 0.198 -0.005
-0.272391 0.198 -0.005
-0.26069 0.194 0.005
-0.272391 0.194 0.005
-0.26069 0.198 0.005
-0.272391 0.198 0.005
-0.272391 0.194 -0.005
-0.284091 0.194 -0.005
-0.272391 0.198 -0.005
-0.284091 0.198 -0.005
-0.272391 0.194 0.005
-0.284091 0.194 0.005
-0.272391 0.198 0.005
-0.284091 0.198 0.005
-0.284091 0.194 -0.005
-0.295791 0.194 -0.005
-0.284091 0.198 -0.005
-0.295791 0.198 -0.005
-0.284091 0.194 0.005
-0.295791 0.194 0.005
-0.284091 0.198 0.005
-0.295791 0.198 0.005
-0.295791 0.194 -0.005
-0.307492 0.194 -0.005
-0.295791 0.198 -0.005
-0.307492 0.198 -0.005
-0.295791 0.194 0.005
-0.307492 0.194 0.005
-0.295791 0.198 0.005
-0.307492 0.198 0.005
-0.307492 0.194 -0.005
-0.319192 0.194 -0.005
-0.307492 0.198 -0.005
-0.319192 0.198 -0.005
-0.307492 0.194 0.005
-0.319192 0.194 0.005
-0.307492 0.198 0.005
-0.319192 0.198 0.005
-0.319192 0.194 -0.005
-0.330892 0.194 -0.005
-0.319192 0.198 -0.005
-0.330892 0.198 -0.005
-0.319192 0.194 0.005
-0.330892 0.194 0.005
-0.319192 0.198 0.005
-0.330892 0.198 0.005
-0.330892 0.194 -0.005
-0.342593 0.194 -0.005
-0.330892 0.198 -0.005
-0.342593 0.198 -0.005
-0.330892 0.194 0.005
-0.342593 0.194 0.005
-0.330892 0.198 0.005
-0.342593 0.198 0.005
-0.342593 0.194 -0.005
-0.354293 0.194 -0.005
-0.342593 0.198 -0.005
-0.354293 0.198 -0.005
-0.342593 0.194 0.005
-0.354293 0.194 0.005
-0.342593 0.198 0.005
-0.354293 0.198 0.005
-0.354293 0.194 -0.005
-0.365993 0.194 -0.005
-0.354293 0.198 -0.005
-0.365993 0.198 -0.005
-0.354293 0.194 0.005
-0.365993 0.194 0.005
-0.354293 0.198 0.005
-0.365993 0.198 0.005
-0.365993 0.194 -0.005
-0.377694 0.194 -0.005
-0.365993 0.198 -0.005
-0.377694 0.198 -0.005
-0.365993 0.194 0.005
-0.377694 0.194 0.005
-0.365993 0.198 0.005
-0.377694 0.198 0.005
-0.377694 0.194 -0.005
-0.389394 0.194 -0.005
-0.377694 0.198 -0.005
-0.389394 0.198 -0.005
-0.377694 0.194 0.005
-0.389394 0.194 0.005
-0.377694 0.198 0.005
-0.389394 0.198 0.005
-0.389394 0.194 -0.005
-0.401094 0.194 -0.005
-0.389394 0.198 -0.005
-0.401094 0.198 -0.005
-0.389394 0.194 0.005
-0.401094 0.194 0.005
-0.389394 0.198 0.005
-0.401094 0.198 0.005
-0.401094 0.194 -0.005
-0.412795 0.194 -0.005
-0.401094 0.198 -0.005
-0.412795 0.198 -0.005
-0.401094 0.194 0.005
-0.412795 0.194 0.005
-0.401094 0.198 0.005
-0.412795 0.198 0.005
-0.412795 0.194 -0.005
-0.424495 0.194 -0.005
-0.412795 0.198 -0.005
-0.424495 0.198 -0.005
-0.412795 0.194 0.005
-0.424495 0.194 0.005
-0.412795 0.198 0.005
-0.424495 0.198 0.005
-0.424495 0.194 -0.005
-0.436195 0.194 -0.005
-0.424495 0.198 -0.005
-0.436195 0.198 -0.005
-0.424495 0.194 0.005
-0.436195 0.194 0.005
-0.424495 0.198 0.005
-0.436195 0.198 0.005
-0.436195 0.194 -0.005
-0.447896 0.194 -0.005
-0.436195 0.198 -0.005
-0.447896 0.198 -0.005
-0.436195 0.194 0.005
-0.447896 0.194 0.005
-0.436195 0.198 0.005
-0.447896 0.198 0.005
-0.447896 0.194 -0.005
-0.459596 0.194 -0.005
-0.447896 0.198 -0.005
-0.459596 0.198 -0.005
-0.447896 0.194 0.005
-0.459596 0.194 0.005
-0.447896 0.198 0.005
-0.459596 0.198 0.005
-0.459596 0.194 -0.005
-0.471296 0.194 -0.005
-0.459596 0.198 -0.005
-0.471296 0.198 -0.005
-0.459596 0.194 0.005
-0.471296 0.194 0.005
-0.459596 0.198 0.005
-0.471296 0.198 0.005
-0.471296 0.194 -0.005
-0.482997 0.194 -0.005
-0.471296 0.198 -0.005
-0.482997 0.198 -0.005
-0.471296 0.194 0.005
-0.482997 0.194 0.005
-0.471296 0.198 0.005
-0.482997 0.198 0.005
-0.482997 0.194 -0.005
-0.494697 0.194 -0.005
-0.482997 0.198 -0.005
-0.494697 0.198 -0.005
-0.482997 0.194 0.005
-0.494697 0.194 0.005
-0.482997 0.198 0.005
-0.494697 0.198 0.005
-0.494697 0.194 -0.005
-0.506397 0.194 -0.005
-0.494697 0.198 -0.005
-0.506397 0.198 -0.005
-0.494697 0.194 0.005
-0.506397 0.194 0.005
-0.494697 0.198 0.005
-0.506397 0.198 0.005
-0.506397 0.194 -0.005
-0.518098 0.194 -0.005
-0.506397 0.198 -0.005
-0.518098 0.198 -0.005
-0.506397 0.194 0.005
-0.518098 0.194 0.005
-0.506397 0.198 0.005
-0.518098 0.198 0.005
-0.518098 0.194 -0.005
-0.529798 0.194 -0.005
-0.518098 0.198 -0.005
-0.529798 0.198 -0.005
-0.518098 0.194 0.005
-0.529798 0.194 0.005
-0.518098 0.198 0.005
-0.529798 0.198 0.005
-0.529798 0.194 -0.005
-0.541498 0.194 -0.005
-0.529798 0.198 -0.005
-0.541498 0.198 -0.005
-0.529798 0.194 0.005
-0.541498 0.194 0.005
-0.529798 0.198 0.005
-0.541498 0.198 0.005
-0.541498 0.194 -0.005
-0.553199 0.194 -0.005
-0.541498 0.198 -0.005
-0.553199 0.198 -0.005
-0.541498 0.194 0.005
-0.553199 0.194 0.005
-0.541498 0.198 0.005
-0.553199 0.198 0.005
-0.553199 0.194 -0.005
-0.564899 0.194 -0.005
-0.553199 0.198 -0.005
-0.564899 0.198 -0.005
-0.553199 0.194 0.005
-0.564899 0.194 0.005
-0.553199 0.198 0.005
-0.564899 0.198 0.005
-0.564899 0.194 -0.005
-0.576599 0.194 -0.005
-0.564899 0.198 -0.005
-0.576599 0.198 -0.005
-0.564899 0.194 0.005
-0.576599 0.194 0.005
-0.564899 0.198 0.005
-0.576599 0.198 0.005
-0.576599 0.194 -0.005
-0.5883 0.194 -0.005
-0.576599 0.198 -0.005
-0.5883 0.198 -0.005
-0.576599 0.194 0.005
-0.5883 0.194 0.005
-0.576599 0.198 0.005
-0.5883 0.198 0.005
-0.5883 0.194 -0.005
-0.6 0.194 -0.005
-0.5883 0.198 -0.005
-0.6 0.198 -0.005
-0.5883 0.194 0.005
-0.6 0.194 0.005
-0.5883 0.198 0.005
-0.6 0.198 0.005
-0.24899 0.198 -0.005
-0.26069 0.198 -0.005
-0.24899 0.202 -0.005
-0.26069 0.202 -0.005
-0.24899 0.198 0.005
-0.26069 0.198 0.005
-0.24899 0.202 0.005
-0.26069 0.202 0.005
-0.26069 0.198 -0.005
-0.272391 0.198 -0.005
-0.26069 0.202 -0.005
-0.272391 0.202 -0.005
-0.26069 0.198 0.005
-0.272391 0.198 0.005
-0.26069 0.202 0.005
-0.272391 0.202 0.005
-0.272391 0.198 -0.005
-0.284091 0.198 -0.005
-0.272391 0.202 -0.005
-0.284091 0.202 -0.005
-0.272391 0.198 0.005
-0.284091 0.198 0.005
-0.272391 0.202 0.005
-0.284091 0.202 0.005
-0.284091 0.198 -0.005
-0.295791 0.198 -0.005
-0.284091 0.202 -0.005
-0.295791 0.202 -0.005
-0.284091 0.198 0.005
-0.295791 0.198 0.005
-0.284091 0.202 0.005
-0.295791 0.202 0.005
-0.295791 0.198 -0.005
-0.307492 0.198 -0.005
-0.295791 0.202 -0.005
-0.307492 0.202 -0.005
-0.295791 0.198 0.005
-0.307492 0.198 0.005
-0.295791 0.202 0.005
-0.307492 0.202 0.005
-0.307492 0.198 -0.005
-0.319192 0.198 -0.005
-0.307492 0.202 -0.005
-0.319192 0.202 -0.005
-0.307492 0.198 0.005
-0.319192 0.198 0.005
-0.307492 0.202 0.005
-0.319192 0.202 0.005
-0.319192 0.198 -0.005
-0.330892 0.198 -0.005
-0.319192 0.202 -0.005
-0.330892 0.202 -0.005
-0.319192 0.198 0.005
-0.330892 0.198 0.005
-0.319192 0.202 0.005
-0.330892 0.202 0.005
-0.330892 0.198 -0.005
-0.342593 0.198 -0.005
-0.330892 0.202 -0.005
-0.342593 0.202 -0.005
-0.330892 0.198 0.005
-0.342593 0.198 0.005
-0.330892 0.202 0.005
-0.342593 0.202 0.005
-0.342593 0.198 -0.005
-0.354293 0.198 -0.005
-0.342593 0.202 -0.005
-0.354293 0.202 -0.005
-0.342593 0.198 0.005
-0.354293 0.198 0.005
-0.342593 0.202 0.005
-0.354293 0.202 0.005
-0.354293 0.198 -0.005
-0.365993 0.198 -0.005
-0.354293 0.202 -0.005
-0.365993 0.202 -0.005
-0.354293 0.198 0.005
-0.365993 0.198 0.005
-0.354293 0.202 0.005
-0.365993 0.202 0.005
-0.365993 0.198 -0.005
-0.377694 0.198 -0.005
-0.365993 0.202 -0.005
-0.377694 0.202 -0.005
-0.365993 0.198 0.005
-0.377694 0.198 0.005
-0.365993 0.202 0.005
-0.377694 0.202 0.005
-0.377694 0.198 -0.005
-0.389394 0.198 -0.005
-0.377694 0.202 -0.005
-0.389394 0.202 -0.005
-0.377694 0.198 0.005
-0.389394 0.198 0.005
-0.377694 0.202 0.005
-0.389394 0.202 0.005
-0.389394 0.198 -0.005
-0.401094 0.198 -0.005
-0.389394 0.202 -0.005
-0.401094 0.202 -0.005
-0.389394 0.198 0.005
-0.401094 0.198 0.005
-0.389394 0.202 0.005
-0.401094 0.202 0.005
-0.401094 0.198 -0.005
-0.412795 0.198 -0.005
-0.401094 0.202 -0.005
-0.412795 0.202 -0.005
-0.401094 0.198 0.005
-0.412795 0.198 0.005
-0.401094 0.202 0.005
-0.412795 0.202 0.005
-0.412795 0.198 -0.005
-0.424495 0.198 -0.005
-0.412795 0.202 -0.005
-0.424495 0.202 -0.005
-0.412795 0.198 0.005
-0.424495 0.198 0.005
-0.412795 0.202 0.005
-0.424495 0.202 0.005
-0.424495 0.198 -0.005
-0.436195 0.198 -0.005
-0.424495 0.202 -0.005
-0.436195 0.202 -0.005
-0.424495 0.198 0.005
-0.436195 0.198 0.005
-0.424495 0.202 0.005
-0.436195 0.202 0.005
-0.436195 0.198 -0.005
-0.447896 0.198 -0.005
-0.436195 0.202 -0.005
-0.447896 0.202 -0.005
-0.436195 0.198 0.005
-0.447896 0.198 0.005
-0.436195 0.202 0.005
-0.447896 0.202 0.005
-0.447896 0.198 -0.005
-0.459596 0.198 -0.005
-0.447896 0.202 -0.005
-0.459596 0.202 -0.005
-0.447896 0.198 0.005
-0.459596 0.198 0.005
-0.447896 0.202 0.005
-0.459596 0.202 0.005
-0.459596 0.198 -0.005
-0.471296 0.198 -0.005
-0.459596 0.202 -0.005
-0.471296 0.202 -0.005
-0.459596 0.198 0.005
-0.471296 0.198 0.005
-0.459596 0.202 0.005
-0.471296 0.202 0.005
-0.471296 0.198 -0.005
-0.482997 0.198 -0.005
-0.471296 0.202 -0.005
-0.482997 0.202 -0.005
-0.471296 0.198 0.005
-0.482997 0.198 0.005
-0.471296 0.202 0.005
-0.482997 0.202 0.005
-0.482997 0.198 -0.005
-0.494697 0.198 -0.005
-0.482997 0.202 -0.005
-0.494697 0.202 -0.005
-0.482997 0.198 0.005
-0.494697 0.198 0.005
-0.482997 0.202 0.005
-0.494697 0.202 0.005
-0.494697 0.198 -0.005
-0.506397 0.198 -0.005
-0.494697 0.202 -0.005
-0.506397 0.202 -0.005
-0.494697 0.198 0.005
-0.506397 0.198 0.005
-0.494697 0.202 0.005
-0.506397 0.202 0.005
-0.506397 0.198 -0.005
-0.518098 0.198 -0.005
-0.506397 0.202 -0.005
-0.518098 0.202 -0.005
-0.506397 0.198 0.005
-0.518098 0.198 0.005
-0.506397 0.202 0.005
-0.518098 0.202 0.005
-0.518098 0.198 -0.005
-0.529798 0.198 -0.005
-0.518098 0.202 -0.005
-0.529798 0.202 -0.005
-0.518098 0.198 0.005
-0.529798 0.198 0.005
-0.518098 0.202 0.005
-0.529798 0.202 0.005
-0.529798 0.198 -0.005
-0.541498 0.198 -0.005
-0.529798 0.202 -0.005
-0.541498 0.202 -0.005
-0.529798 0.198 0.005
-0.541498 0.198 0.005
-0.529798 0.202 0.005
-0.541498 0.202 0.005
-0.541498 0.198 -0.005
-0.553199 0.198 -0.005
-0.541498 0.202 -0.005
-0.553199 0.202 -0.005
-0.541498 0.198 0.005
-0.553199 0.198 0.005
-0.541498 0.202 0.005
-0.553199 0.202 0.005
-0.553199 0.198 -0.005
-0.564899 0.198 -0.005
-0.553199 0.202 -0.005
-0.564899 0.202 -0.005
-0.553199 0.198 0.005
-0.564899 0.198 0.005
-0.553199 0.202 0.005
-0.564899 0.202 0.005
-0.564899 0.198 -0.005
-0.576599 0.198 -0.005
-0.564899 0.202 -0.005
-0.576599 0.202 -0.005
-0.564899 0.198 0.005
-0.576599 0.198 0.005
-0.564899 0.202 0.005
-0.576599 0.202 0.005
-0.576599 0.198 -0.005
-0.5883 0.198 -0.005
-0.576599 0.202 -0.005
-0.5883 0.202 -0.005
-0.576599 0.198 0.005
-0.5883 0.198 0.005
-0.576599 0.202 0.005
-0.5883 0.202 0.005
-0.5883 0.198 -0.005
-0.6 0.198 -0.005
-0.5883 0.202 -0.005
-0.6 0.202 -0.005
-0.5883 0.198 0.005
-0.6 0.198 0.005
-0.5883 0.202 0.005
-0.6 0.202 0.005
-0.24899 0.202 -0.005
-0.26069 0.202 -0.005
-0.24899 0.206 -0.005
-0.26069 0.206 -0.005
-0.24899 0.202 0.005
-0.26069 0.202 0.005
-0.24899 0.206 0.005
-0.26069 0.206 0.005
-0.26069 0.202 -0.005
-0.272391 0.202 -0.005
-0.26069 0.206 -0.005
-0.272391 0.206 -0.005
-0.26069 0.202 0.005
-0.272391 0.202 0.005
-0.26069 0.206 0.005
-0.272391 0.206 0.005
-0.272391 0.202 -0.005
-0.284091 0.202 -0.005
-0.272391 0.206 -0.005
-0.284091 0.206 -0.005
-0.272391 0.202 0.005
-0.284091 0.202 0.005
-0.272391 0.206 0.005
-0.284091 0.206 0.005
-0.284091 0.202 -0.005
-0.295791 0.202 -0.005
-0.284091 0.206 -0.005
-0.295791 0.206 -0.005
-0.284091 0.202 0.005
-0.295791 0.202 0.005
-0.284091 0.206 0.005
-0.295791 0.206 0.005
-0.295791 0.202 -0.005
-0.307492 0.202 -0.005
-0.295791 0.206 -0.005
-0.307492 0.206 -0.005
-0.295791 0.202 0.005
-0.307492 0.202 0.005
-0.295791 0.206 0.005
-0.307492 0.206 0.005
-0.307492 0.202 -0.005
-0.319192 0.202 -0.005
-0.307492 0.206 -0.005
-0.319192 0.206 -0.005
-0.307492 0.202 0.005
-0.319192 0.202 0.005
-0.307492 0.206 0.005
-0.319192 0.206 0.005
-0.319192 0.202 -0.005
-0.330892 0.202 -0.005
-0.319192 0.206 -0.005
-0.330892 0.206 -0.005
-0.319192 0.202 0.005
-0.330892 0.202 0.005
-0.319192 0.206 0.005
-0.330892 0.206 0.005
-0.330892 0.202 -0.005
-0.342593 0.202 -0.005
-0.330892 0.206 -0.005
-0.342593 0.206 -0.005
-0.330892 0.202 0.005
-0.342593 0.202 0.005
-0.330892 0.206 0.005
-0.342593 0.206 0.005
-0.342593 0.202 -0.005
-0.354293 0.202 -0.005
-0.342593 0.206 -0.005
-0.354293 0.206 -0.005
-0.342593 0.202 0.005
-0.354293 0.202 0.005
-0.342593 0.206 0.005
-0.354293 0.206 0.005
-0.354293 0.202 -0.005
-0.365993 0.202 -0.005
-0.354293 0.206 -0.005
-0.365993 0.206 -0.005
-0.354293 0.202 0.005
-0.365993 0.202 0.005
-0.354293 0.206 0.005
-0.365993 0.206 0.005
-0.365993 0.202 -0.005
-0.377694 0.202 -0.005
-0.365993 0.206 -0.005
-0.377694 0.206 -0.005
-0.365993 0.202 0.005
-0.377694 0.202 0.005
-0.365993 0.206 0.005
-0.377694 0.206 0.005
-0.377694 0.202 -0.005
-0.389394 0.202 -0.005
-0.377694 0.206 -0.005
-0.389394 0.206 -0.005
-0.377694 0.202 0.005
-0.389394 0.202 0.005
-0.377694 0.206 0.005
-0.389394 0.206 0.005
-0.389394 0.202 -0.005
-0.401094 0.202 -0.005
-0.389394 0.206 -0.005
-0.401094 0.206 -0.005
-0.389394 0.202 0.005
-0.401094 0.202 0.005
-0.389394 0.206 0.005
-0.401094 0.206 0.005
-0.401094 0.202 -0.005
-0.412795 0.202 -0.005
-0.401094 0.206 -0.005
-0.412795 0.206 -0.005
-0.401094 0.202 0.005
-0.412795 0.202 0.005
-0.401094 0.206 0.005
-0.412795 0.206 0.005
-0.412795 0.202 -0.005
-0.424495 0.202 -0.005
-0.412795 0.206 -0.005
-0.424495 0.206 -0.005
-0.412795 0.202 0.005
-0.424495 0.202 0.005
-0.412795 0.206 0.005
-0.424495 0.206 0.005
-0.424495 0.202 -0.005
-0.436195 0.202 -0.005
-0.424495 0.206 -0.005
-0.436195 0.206 -0.005
-0.424495 0.202 0.005
-0.436195 0.202 0.005
-0.424495 0.206 0.005
-0.436195 0.206 0.005
-0.436195 0.202 -0.005
-0.447896 0.202 -0.005
-0.436195 0.206 -0.005
-0.447896 0.206 -0.005
-0.436195 0.202 0.005
-0.447896 0.202 0.005
-0.436195 0.206 0.005
-0.447896 0.206 0.005
-0.447896 0.202 -0.005
-0.459596 0.202 -0.005
-0.447896 0.206 -0.005
-0.459596 0.206 -0.005
-0.447896 0.202 0.005
-0.459596 0.202 0.005
-0.447896 0.206 0.005
-0.459596 0.206 0.005
-0.459596 0.202 -0.005
-0.471296 0.202 -0.005
-0.459596 0.206 -0.005
-0.471296 0.206 -0.005
-0.459596 0.202 0.005
-0.471296 0.202 0.005
-0.459596 0.206 0.005
-0.471296 0.206 0.005
-0.471296 0.202 -0.005
-0.482997 0.202 -0.005
-0.471296 0.206 -0.005
-0.482997 0.206 -0.005
-0.471296 0.202 0.005
-0.482997 0.202 0.005
-0.471296 0.206 0.005
-0.482997 0.206 0.005
-0.482997 0.202 -0.005
-0.494697 0.202 -0.005
-0.482997 0.206 -0.005
-0.494697 0.206 -0.005
-0.482997 0.202 0.005
-0.494697 0.202 0.005
-0.482997 0.206 0.005
-0.494697 0.206 0.005
-0.494697 0.202 -0.005
-0.506397 0.202 -0.005
-0.494697 0.206 -0.005
-0.506397 0.206 -0.005
-0.494697 0.202 0.005
-0.506397 0.202 0.005
-0.494697 0.206 0.005
-0.506397 0.206 0.005
-0.506397 0.202 -0.005
-0.518098 0.202 -0.005
-0.506397 0.206 -0.005
-0.518098 0.206 -0.005
-0.506397 0.202 0.005
-0.518098 0.202 0.005
-0.506397 0.206 0.005
-0.518098 0.206 0.005
-0.518098 0.202 -0.005
-0.529798 0.202 -0.005
-0.518098 0.206 -0.005
-0.529798 0.206 -0.005
-0.518098 0.202 0.005
-0.529798 0.202 0.005
-0.518098 0.206 0.005
-0.529798 0.206 0.005
-0.529798 0.202 -0.005
-0.541498 0.202 -0.005
-0.529798 0.206 -0.005
-0.541498 0.206 -0.005
-0.529798 0.202 0.005
-0.541498 0.202 0.005
-0.529798 0.206 0.005
-0.541498 0.206 0.005
-0.541498 0.202 -0.005
-0.553199 0.202 -0.005
-0.541498 0.206 -0.005
-0.553199 0.206 -0.005
-0.541498 0.202 0.005
-0.553199 0.202 0.005
-0.541498 0.206 0.005
-0.553199 0.206 0.005
-0.553199 0.202 -0.005
-0.564899 0.202 -0.005
-0.553199 0.206 -0.005
-0.564899 0.206 -0.005
-0.553199 0.202 0.005
-0.564899 0.202 0.005
-0.553199 0.206 0.005
-0.564899 0.206 0.005
-0.564899 0.202 -0.005
-0.576599 0.202 -0.005
-0.564899 0.206 -0.005
-0.576599 0.206 -0.005
-0.564899 0.202 0.005
-0.576599 0.202 0.005
-0.564899 0.206 0.005
-0.576599 0.206 0.005
-0.576599 0.202 -0.005
-0.5883 0.202 -0.005
-0.576599 0.206 -0.005
-0.5883 0.206 -0.005
-0.576599 0.202 0.005
-0.5883 0.202 0.005
-0.576599 0.206 0.005
-0.5883 0.206 0.005
-0.5883 0.202 -0.005
-0.6 0.202 -0.005
-0.5883 0.206 -0.005
-0.6 0.206 -0.005
-0.5883 0.202 0.005
-0.6 0.202 0.005
-0.5883 0.206 0.005
-0.6 0.206 0.005
-0.24899 0.206 -0.005
-0.26069 0.206 -0.005
-0.24899 0.21 -0.005
-0.26069 0.21 -0.005
-0.24899 0.206 0.005
-0.26069 0.206 0.005
-0.24899 0.21 0.005
-0.26069 0.21 0.005
-0.26069 0.206 -0.005
-0.272391 0.206 -0.005
-0.26069 0.21 -0.005
-0.272391 0.21 -0.005
-0.26069 0.206 0.005
-0.272391 0.206 0.005
-0.26069 0.21 0.005
-0.272391 0.21 0.005
-0.272391 0.206 -0.005
-0.284091 0.206 -0.005
-0.272391 0.21 -0.005
-0.284091 0.21 -0.005
-0.272391 0.206 0.005
-0.284091 0.206 0.005
-0.272391 0.21 0.005
-0.284091 0.21 0.005
-0.284091 0.206 -0.005
-0.295791 0.206 -0.005
-0.284091 0.21 -0.005
-0.295791 0.21 -0.005
-0.284091 0.206 0.005
-0.295791 0.206 0.005
-0.284091 0.21 0.005
-0.295791 0.21 0.005
-0.295791 0.206 -0.005
-0.307492 0.206 -0.005
-0.295791 0.21 -0.005
-0.307492 0.21 -0.005
-0.295791 0.206 0.005
-0.307492 0.206 0.005
-0.295791 0.21 0.005
-0.307492 0.21 0.005
-0.307492 0.206 -0.005
-0.319192 0.206 -0.005
-0.307492 0.21 -0.005
-0.319192 0.21 -0.005
-0.307492 0.206 0.005
-0.319192 0.206 0.005
-0.307492 0.21 0.005
-0.319192 0.21 0.005
-0.319192 0.206 -0.005
-0.330892 0.206 -0.005
-0.319192 0.21 -0.005
-0.330892 0.21 -0.005
-0.319192 0.206 0.005
-0.330892 0.206 0.005
-0.319192 0.21 0.005
-0.330892 0.21 0.005
-0.330892 0.206 -0.005
-0.342593 0.206 -0.005
-0.330892 0.21 -0.005
-0.342593 0.21 -0.005
-0.330892 0.206 0.005
-0.342593 0.206 0.005
-0.330892 0.21 0.005
-0.342593 0.21 0.005
-0.342593 0.206 -0.005
-0.354293 0.206 -0.005
-0.342593 0.21 -0.005
-0.354293 0.21 -0.005
-0.342593 0.206 0.005
-0.354293 0.206 0.005
-0.342593 0.21 0.005
-0.354293 0.21 0.005
-0.354293 0.206 -0.005
-0.365993 0.206 -0.005
-0.354293 0.21 -0.005
-0.365993 0.21 -0.005
-0.354293 0.206 0.005
-0.365993 0.206 0.005
-0.354293 0.21 0.005
-0.365993 0.21 0.005
-0.365993 0.206 -0.005
-0.377694 0.206 -0.005
-0.365993 0.21 -0.005
-0.377694 0.21 -0.005
-0.365993 0.206 0.005
-0.377694 0.206 0.005
-0.365993 0.21 0.005
-0.377694 0.21 0.005
-0.377694 0.206 -0.005
-0.389394 0.206 -0.005
-0.377694 0.21 -0.005
-0.389394 0.21 -0.005
-0.377694 0.206 0.005
-0.389394 0.206 0.005
-0.377694 0.21 0.005
-0.389394 0.21 0.005
-0.389394 0.206 -0.005
-0.401094 0.206 -0.005
-0.389394 0.21 -0.005
-0.401094 0.21 -0.005
-0.389394 0.206 0.005
-0.401094 0.206 0.005
-0.389394 0.21 0.005
-0.401094 0.21 0.005
-0.401094 0.206 -0.005
-0.412795 0.206 -0.005
-0.401094 0.21 -0.005
-0.412795 0.21 -0.005
-0.401094 0.206 0.005
-0.412795 0.206 0.005
-0.401094 0.21 0.005
-0.412795 0.21 0.005
-0.412795 0.206 -0.005
-0.424495 0.206 -0.005
-0.412795 0.21 -0.005
-0.424495 0.21 -0.005
-0.412795 0.206 0.005
-0.424495 0.206 0.005
-0.412795 0.21 0.005
-0.424495 0.21 0.005
-0.424495 0.206 -0.005
-0.436195 0.206 -0.005
-0.424495 0.21 -0.005
-0.436195 0.21 -0.005
-0.424495 0.206 0.005
-0.436195 0.206 0.005
-0.424495 0.21 0.005
-0.436195 0.21 0.005
-0.436195 0.206 -0.005
-0.447896 0.206 -0.005
-0.436195 0.21 -0.005
-0.447896 0.21 -0.005
-0.436195 0.206 0.005
-0.447896 0.206 0.005
-0.436195 0.21 0.005
-0.447896 0.21 0.005
-0.447896 0.206 -0.005
-0.459596 0.206 -0.005
-0.447896 0.21 -0.005
-0.459596 0.21 -0.005
-0.447896 0.206 0.005
-0.459596 0.206 0.005
-0.447896 0.21 0.005
-0.459596 0.21 0.005
-0.459596 0.206 -0.005
-0.471296 0.206 -0.005
-0.459596 0.21 -0.005
-0.471296 0.21 -0.005
-0.459596 0.206 0.005
-0.471296 0.206 0.005
-0.459596 0.21 0.005
-0.471296 0.21 0.005
-0.471296 0.206 -0.005
-0.482997 0.206 -0.005
-0.471296 0.21 -0.005
-0.482997 0.21 -0.005
-0.471296 0.206 0.005
-0.482997 0.206 0.005
-0.471296 0.21 0.005
-0.482997 0.21 0.005
-0.482997 0.206 -0.005
-0.494697 0.206 -0.005
-0.482997 0.21 -0.005
-0.494697 0.21 -0.005
-0.482997 0.206 0.005
-0.494697 0.206 0.005
-0.482997 0.21 0.005
-0.494697 0.21 0.005
-0.494697 0.206 -0.005
-0.506397 0.206 -0.005
-0.494697 0.21 -0.005
-0.506397 0.21 -0.005
-0.494697 0.206 0.005
-0.506397 0.206 0.005
-0.494697 0.21 0.005
-0.506397 0.21 0.005
-0.506397 0.206 -0.005
-0.518098 0.206 -0.005
-0.506397 0.21 -0.005
-0.518098 0.21 -0.005
-0.506397 0.206 0.005
-0.518098 0.206 0.005
-0.506397 0.21 0.005
-0.518098 0.21 0.005
-0.518098 0.206 -0.005
-0.529798 0.206 -0.005
-0.518098 0.21 -0.005
-0.529798 0.21 -0.005
-0.518098 0.206 0.005
-0.529798 0.206 0.005
-0.518098 0.21 0.005
-0.529798 0.21 0.005
-0.529798 0.206 -0.005
-0.541498 0.206 -0.005
-0.529798 0.21 -0.005
-0.541498 0.21 -0.005
-0.529798 0.206 0.005
-0.541498 0.206 0.005
-0.529798 0.21 0.005
-0.541498 0.21 0.005
-0.541498 0.206 -0.005
-0.553199 0.206 -0.005
-0.541498 0.21 -0.005
-0.553199 0.21 -0.005
-0.541498 0.206 0.005
-0.553199 0.206 0.005
-0.541498 0.21 0.005
-0.553199 0.21 0.005
-0.553199 0.206 -0.005
-0.564899 0.206 -0.005
-0.553199 0.21 -0.005
-0.564899 0.21 -0.005
-0.553199 0.206 0.005
-0.564899 0.206 0.005
-0.553199 0.21 0.005
-0.564899 0.21 0.005
-0.564899 0.206 -0.005
-0.576599 0.206 -0.005
-0.564899 0.21 -0.005
-0.576599 0.21 -0.005
-0.564899 0.206 0.005
-0.576599 0.206 0.005
-0.564899 0.21 0.005
-0.576599 0.21 0.005
-0.576599 0.206 -0.005
-0.5883 0.206 -0.005
-0.576599 0.21 -0.005
-0.5883 0.21 -0.005
-0.576599 0.206 0.005
-0.5883 0.206 0.005
-0.576599 0.21 0.005
-0.5883 0.21 0.005
-0.5883 0.206 -0.005
-0.6 0.206 -0.005
-0.5883 0.21 -0.005
-0.6 0.21 -0.005
-0.5883 0.206 0.005
-0.6 0.206 0.005
-0.5883 0.21 0.005
-0.6 0.21 0.005
-
-CELLS 150 1350
-8 0 1 3 2 4 5 7 6
-8 8 9 11 10 12 13 15 14
-8 16 17 19 18 20 21 23 22
-8 24 25 27 26 28 29 31 30
-8 32 33 35 34 36 37 39 38
-8 40 41 43 42 44 45 47 46
-8 48 49 51 50 52 53 55 54
-8 56 57 59 58 60 61 63 62
-8 64 65 67 66 68 69 71 70
-8 72 73 75 74 76 77 79 78
-8 80 81 83 82 84 85 87 86
-8 88 89 91 90 92 93 95 94
-8 96 97 99 98 100 101 103 102
-8 104 105 107 106 108 109 111 110
-8 112 113 115 114 116 117 119 118
-8 120 121 123 122 124 125 127 126
-8 128 129 131 130 132 133 135 134
-8 136 137 139 138 140 141 143 142
-8 144 145 147 146 148 149 151 150
-8 152 153 155 154 156 157 159 158
-8 160 161 163 162 164 165 167 166
-8 168 169 171 170 172 173 175 174
-8 176 177 179 178 180 181 183 182
-8 184 185 187 186 188 189 191 190
-8 192 193 195 194 196 197 199 198
-8 200 201 203 202 204 205 207 206
-8 208 209 211 210 212 213 215 214
-8 216 217 219 218 220 221 223 222
-8 224 225 227 226 228 229 231 230
-8 232 233 235 234 236 237 239 238
-8 240 241 243 242 244 245 247 246
-8 248 249 251 250 252 253 255 254
-8 256 257 259 258 260 261 263 262
-8 264 265 267 266 268 269 271 270
-8 272 273 275 274 276 277 279 278
-8 280 281 283 282 284 285 287 286
-8 288 289 291 290 292 293 295 294
-8 296 297 299 298 300 301 303 302
-8 304 305 307 306 308 309 311 310
-8 312 313 315 314 316 317 319 318
-8 320 321 323 322 324 325 327 326
-8 328 329 331 330 332 333 335 334
-8 336 337 339 338 340 341 343 342
-8 344 345 347 346 348 349 351 350
-8 352 353 355 354 356 357 359 358
-8 360 361 363 362 364 365 367 366
-8 368 369 371 370 372 373 375 374
-8 376 377 379 378 380 381 383 382
-8 384 385 387 386 388 389 391 390
-8 392 393 395 394 396 397 399 398
-8 400 401 403 402 404 405 407 406
-8 408 409 411 410 412 413 415 414
-8 416 417 419 418 420 421 423 422
-8 424 425 427 426 428 429 431 430
-8 432 433 435 434 436 437 439 438
-8 440 441 443 442 444 445 447 446
-8 448 449 451 450 452 453 455 454
-8 456 457 459 458 460 461 463 462
-8 464 465 467 466 468 469 471 470
-8 472 473 475 474 476 477 479 478
-8 480 481 483 482 484 485 487 486
-8 488 489 491 490 492 493 495 494
-8 496 497 499 498 500 501 503 502
-8 504 505 507 506 508 509 511 510
-8 512 513 515 514 516 517 519 518
-8 520 521 523 522 524 525 527 526
-8 528 529 531 530 532 533 535 534
-8 536 537 539 538 540 541 543 542
-8 544 545 547 546 548 549 551 550
-8 552 553 555 554 556 557 559 558
-8 560 561 563 562 564 565 567 566
-8 568 569 571 570 572 573 575 574
-8 576 577 579 578 580 581 583 582
-8 584 585 587 586 588 589 591 590
-8 592 593 595 594 596 597 599 598
-8 600 601 603 602 604 605 607 606
-8 608 609 611 610 612 613 615 614
-8 616 617 619 618 620 621 623 622
-8 624 625 627 626 628 629 631 630
-8 632 633 635 634 636 637 639 638
-8 640 641 643 642 644 645 647 646
-8 648 649 651 650 652 653 655 654
-8 656 657 659 658 660 661 663 662
-8 664 665 667 666 668 669 671 670
-8 672 673 675 674 676 677 679 678
-8 680 681 683 682 684 685 687 686
-8 688 689 691 690 692 693 695 694
-8 696 697 699 698 700 701 703 702
-8 704 705 707 706 708 709 711 710
-8 712 713 715 714 716 717 719 718
-8 720 721 723 722 724 725 727 726
-8 728 729 731 730 732 733 735 734
-8 736 737 739 738 740 741 743 742
-8 744 745 747 746 748 749 751 750
-8 752 753 755 754 756 757 759 758
-8 760 761 763 762 764 765 767 766
-8 768 769 771 770 772 773 775 774
-8 776 777 779 778 780 781 783 782
-8 784 785 787 786 788 789 791 790
-8 792 793 795 794 796 797 799 798
-8 800 801 803 802 804 805 807 806
-8 808 809 811 810 812 813 815 814
-8 816 817 819 818 820 821 823 822
-8 824 825 827 826 828 829 831 830
-8 832 833 835 834 836 837 839 838
-8 840 841 843 842 844 845 847 846
-8 848 849 851 850 852 853 855 854
-8 856 857 859 858 860 861 863 862
-8 864 865 867 866 868 869 871 870
-8 872 873 875 874 876 877 879 878
-8 880 881 883 882 884 885 887 886
-8 888 889 891 890 892 893 895 894
-8 896 897 899 898 900 901 903 902
-8 904 905 907 906 908 909 911 910
-8 912 913 915 914 916 917 919 918
-8 920 921 923 922 924 925 927 926
-8 928 929 931 930 932 933 935 934
-8 936 937 939 938 940 941 943 942
-8 944 945 947 946 948 949 951 950
-8 952 953 955 954 956 957 959 958
-8 960 961 963 962 964 965 967 966
-8 968 969 971 970 972 973 975 974
-8 976 977 979 978 980 981 983 982
-8 984 985 987 986 988 989 991 990
-8 992 993 995 994 996 997 999 998
-8 1000 1001 1003 1002 1004 1005 1007 1006
-8 1008 1009 1011 1010 1012 1013 1015 1014
-8 1016 1017 1019 1018 1020 1021 1023 1022
-8 1024 1025 1027 1026 1028 1029 1031 1030
-8 1032 1033 1035 1034 1036 1037 1039 1038
-8 1040 1041 1043 1042 1044 1045 1047 1046
-8 1048 1049 1051 1050 1052 1053 1055 1054
-8 1056 1057 1059 1058 1060 1061 1063 1062
-8 1064 1065 1067 1066 1068 1069 1071 1070
-8 1072 1073 1075 1074 1076 1077 1079 1078
-8 1080 1081 1083 1082 1084 1085 1087 1086
-8 1088 1089 1091 1090 1092 1093 1095 1094
-8 1096 1097 1099 1098 1100 1101 1103 1102
-8 1104 1105 1107 1106 1108 1109 1111 1110
-8 1112 1113 1115 1114 1116 1117 1119 1118
-8 1120 1121 1123 1122 1124 1125 1127 1126
-8 1128 1129 1131 1130 1132 1133 1135 1134
-8 1136 1137 1139 1138 1140 1141 1143 1142
-8 1144 1145 1147 1146 1148 1149 1151 1150
-8 1152 1153 1155 1154 1156 1157 1159 1158
-8 1160 1161 1163 1162 1164 1165 1167 1166
-8 1168 1169 1171 1170 1172 1173 1175 1174
-8 1176 1177 1179 1178 1180 1181 1183 1182
-8 1184 1185 1187 1186 1188 1189 1191 1190
-8 1192 1193 1195 1194 1196 1197 1199 1198
-
-CELL_TYPES 150
- 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12
-POINT_DATA 1200
-VECTORS displacement double
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-SCALARS strain_xx double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_xy double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_xz double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_yx double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_yy double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_yz double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_zx double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_zy double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_zz double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/linear_elasticity.prm b/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/linear_elasticity.prm
deleted file mode 100644
index 1a7464616..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/linear_elasticity.prm
+++ /dev/null
@@ -1,68 +0,0 @@
-# Listing of Parameters
-# Dimensional quantities are in SI units
-# --------------------------------------
-
-subsection Time
- # End time
- set End time = 15
-
- # Time step size
- set Time step size = 0.002
-
- # Write results every x timesteps
- set Output interval = 100
-end
-
-subsection Discretization
- # Time integration scheme
- # 0 = forward, 1 = backward
- set theta = 0.5
-
- # Polynomial degree of the FE system
- set Polynomial degree = 2
-end
-
-subsection System properties
- # mu (shear modulus)
- set mu = 2e6
-
- # lambda
- set lambda = 8e6
-
- # density
- set rho = 1000
-
- # body forces x,y,z
- set body forces = 0.0,0.0,0.0
-end
-
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
-
- # Linear solver: CG or Direct
- set Solver type = Direct
-end
-
-subsection precice configuration
- # Cases: FSI3 or PF for perpendicular flap
- set Scenario = FSI3
-
- # Name of the precice configuration file
- set precice config-file = precice-config.xml
-
- # Name of the participant in the precice-config.xml file
- set Participant name = Solid
-
- # Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
-
- # Name of the read data in the precice-config.xml file
- set Read data name = Stress
-
- # Name of the write data in the precice-config.xml file
- set Write data name = Displacement
-end
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm b/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
deleted file mode 100644
index cd606404b..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
+++ /dev/null
@@ -1,81 +0,0 @@
-# Listing of Parameters
-# Dimensional quantities are in SI units
-# --------------------------------------
-
-subsection Time
- # End time
- set End time = 15
-
- # Time step size
- set Time step size = 0.002
-
- # Output interval
- set Output interval = 100
-end
-
-subsection Discretization
- # Newmark beta
- set beta = 0.25
-
- # Newmark gamma
- set gamma = 0.5
-
- # Polynomial degree of the FE system
- set Polynomial degree = 2
-end
-
-subsection System properties
- # Poisson's ratio
- set Poisson's ratio = 0.4
-
- # Shear modulus
- set Shear modulus = 2.0e6
-
- # Density
- set rho = 1000
-
- # Body forces x,y,z
- set body forces = 0.0,0.0,0.0
-end
-
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
-
- # Linear solver: CG or Direct
- set Solver type = Direct
-end
-
-subsection Nonlinear solver
- # Number of Newton-Raphson iterations allowed
- set Max iterations Newton-Raphson = 10
-
- # Displacement error tolerance
- set Tolerance displacement = 1.0e-6
-
- # Force residual tolerance
- set Tolerance force = 1.0e-9
-end
-
-subsection precice configuration
- # Cases: FSI3 or PF for perpendicular flap
- set Scenario = FSI3
-
- # Name of the precice configuration file
- set precice config-file = precice-config.xml
-
- # Name of the participant in the precice-config.xml file
- set Participant name = Solid
-
- # Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
-
- # Name of the read data in the precice-config.xml file
- set Read data name = Stress
-
- # Name of the write data in the precice-config.xml file
- set Write data name = Displacement
-end
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/precice-config.xml b/FSI/cylinderFlap/OpenFOAM-deal.II/precice-config.xml
deleted file mode 100644
index 6ed7e785a..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/precice-config.xml
+++ /dev/null
@@ -1,82 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/removeObsoleteFolders.sh b/FSI/cylinderFlap/OpenFOAM-deal.II/removeObsoleteFolders.sh
deleted file mode 100755
index 6866c8c42..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,22 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/runFluid b/FSI/cylinderFlap/OpenFOAM-deal.II/runFluid
deleted file mode 100755
index 3223006a0..000000000
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/runFluid
+++ /dev/null
@@ -1,42 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the execute the coupled_elasto_dynamics bindary
-# in another terminal.
-# These scripts present how the two participants would be started manually.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- solver=$(getApplication)
- procs=$(getNumberOfProcessors)
-cd ..
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $procs $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26 (OF-adapter, relevant for OF .com versions)
-./removeObsoleteFolders.sh
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/.gitignore b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/.gitignore
deleted file mode 100644
index 7057a0582..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/.gitignore
+++ /dev/null
@@ -1,16 +0,0 @@
-!Fluid
-Fluid/*
-!Fluid/0
-!Fluid/0.orig
-!Fluid/constant
-Fluid/constant/polyMesh
-!Fluid/system
-!Fluid/Fluid.foam
-!Fluid/precice-adapter-config.yml
-!Solid
-Solid/*
-!Solid/cyl-flap.py
-!Solid/precice-adapter-config-fsi-s.json
-*.log
-precice-fenics-events.json
-precice-Fluid-events.json
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/U b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/U
deleted file mode 100644
index d5a072d6e..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/U
+++ /dev/null
@@ -1,65 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
-
- cylinder
- {
- type noSlip;
- }
-
- flap
- {
- type movingWallVelocity;
- value uniform (0 0 0);
- }
-
- top
- {
- type noSlip;
- }
-
- bottom
- {
- type noSlip;
- }
-
- inlet
- {
- // Time-varying inlet velocity
- type uniformFixedValue;
- uniformValue table
- (
- ( 0 ( 0 0 0 ) )
- ( 2. ( 2. 0 0 ) )
- ( 100 ( 2. 0 0 ) )
- );
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/pointDisplacement b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/pointDisplacement
deleted file mode 100644
index f4644920d..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/pointDisplacement
+++ /dev/null
@@ -1,58 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class pointVectorField;
- object pointDisplacement;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 0 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- cylinder
- {
- type fixedValue;
- value $internalField;
- }
- flap
- {
- type fixedValue;
- value $internalField;
- }
-
- top
- {
- type slip;
- }
-
- bottom
- {
- type slip;
- }
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/vorticity b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/vorticity
deleted file mode 100644
index fac7fdf61..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0.orig/vorticity
+++ /dev/null
@@ -1,64 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- location "0";
- object vorticity;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- cylinder
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- flap
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- inlet
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- top
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- bottom
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/U b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/U
deleted file mode 100644
index d5a072d6e..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/U
+++ /dev/null
@@ -1,65 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
-
- cylinder
- {
- type noSlip;
- }
-
- flap
- {
- type movingWallVelocity;
- value uniform (0 0 0);
- }
-
- top
- {
- type noSlip;
- }
-
- bottom
- {
- type noSlip;
- }
-
- inlet
- {
- // Time-varying inlet velocity
- type uniformFixedValue;
- uniformValue table
- (
- ( 0 ( 0 0 0 ) )
- ( 2. ( 2. 0 0 ) )
- ( 100 ( 2. 0 0 ) )
- );
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/pointDisplacement b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/pointDisplacement
deleted file mode 100644
index f4644920d..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/pointDisplacement
+++ /dev/null
@@ -1,58 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class pointVectorField;
- object pointDisplacement;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 0 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- cylinder
- {
- type fixedValue;
- value $internalField;
- }
- flap
- {
- type fixedValue;
- value $internalField;
- }
-
- top
- {
- type slip;
- }
-
- bottom
- {
- type slip;
- }
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/vorticity b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/vorticity
deleted file mode 100644
index fac7fdf61..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/vorticity
+++ /dev/null
@@ -1,64 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- location "0";
- object vorticity;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- cylinder
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- flap
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- inlet
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- top
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- bottom
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/Fluid.foam b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/transportProperties b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/transportProperties
deleted file mode 100644
index 870a0bb1c..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/transportProperties
+++ /dev/null
@@ -1,14 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location constant;
- object transportProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- transportModel Newtonian;
-
- nu nu [0 2 -1 0 0 0 0 ] 0.001;
- pRef pRef [1 -1 -2 0 0 0 0 ] 0.0;
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/turbulenceProperties b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/turbulenceProperties
deleted file mode 100644
index f906d4153..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/turbulenceProperties
+++ /dev/null
@@ -1,11 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location constant;
- object turbulenceProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-simulationType laminar;
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/controlDict b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/controlDict
deleted file mode 100644
index 78e515567..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/controlDict
+++ /dev/null
@@ -1,49 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location system;
- object controlDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-// Note: With OpenFOAM v1806 and OpenFOAM 6, the DyM solvers
-// were marked deprecated and merged into their respective standard solvers.
-application pimpleFoam; // OpenFOAM v1806, OpenFOAM 6, or newer
-//application pimpleDyMFoam; // OpenFOAM v1712, OpenFOAM 5.x, or older
-
-startFrom startTime;
-
-startTime 0;
-
-stopAt endTime;
-
-endTime 25;
-
-deltaT 0.005;
-
-writeControl adjustableRunTime;
-
-writeInterval 0.1;
-
-purgeWrite 0;
-
-writeFormat ascii;
-
-writePrecision 10;
-
-writeCompression off;
-
-timeFormat general;
-
-timePrecision 12;
-
-functions
-{
- preCICE_Adapter
- {
- type preciceAdapterFunctionObject;
- libs ("libpreciceAdapterFunctionObject.so");
- }
-}
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/decomposeParDict b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/decomposeParDict
deleted file mode 100644
index c72a5d50e..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/decomposeParDict
+++ /dev/null
@@ -1,25 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location system;
- object decomposeParDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- numberOfSubdomains 6;
-
- method hierarchical;
- hierarchicalCoeffs
- {
- n (3 2 1);
- delta 0.001;
- order xyz;
- }
-
- distributed false;
- roots
- (
- );
-
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/preciceDict b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/preciceDict
deleted file mode 100644
index ae6131716..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/preciceDict
+++ /dev/null
@@ -1,54 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object preciceDict;
-}
-
-preciceConfig "precice-config.xml";
-
-participant Fluid;
-
-modules (FSI);
-
-interfaces
-{
- Interface1
- {
- mesh Fluid-Mesh-Faces;
- patches (flap);
- locations faceCenters;
-
- readData
- (
- );
-
- writeData
- (
- Forces0
- );
- };
-
- Interface2
- {
- mesh Fluid-Mesh-Nodes;
- patches (flap);
- locations faceNodes;
-
- readData
- (
- Displacements0
- );
-
- writeData
- (
- );
- };
-};
-
-FSI
-{
- rho rho [1 -3 0 0 0 0 0] 1000;
-}
\ No newline at end of file
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Postprocessing/plot_tip.py b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Postprocessing/plot_tip.py
deleted file mode 100644
index 1247119d0..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Postprocessing/plot_tip.py
+++ /dev/null
@@ -1,18 +0,0 @@
-#!/usr/bin/env python3
-# -*- coding: utf-8 -*-
-"""
-Created on Thu May 23 15:07:54 2019
-
-@author: richyrich
-"""
-
-import numpy as np
-import matplotlib.pyplot as plt
-
-fenics_watchpoint = np.loadtxt('../precice-fenics-watchpoint-point1.log', skiprows = 1)
-ccx_watchpoint = np.loadtxt('/home/richyrich/Bachelorarbeit/OpenFOAM-CalculiX/precice-Fluid-watchpoint-point1.log', skiprows = 1)
-
-
-plt.plot(fenics_watchpoint[:, 0], fenics_watchpoint[:, 8])
-
-#plt.plot(ccx_watchpoint[:,0],ccx_watchpoint[:,8])
\ No newline at end of file
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/README.md b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/README.md
deleted file mode 100644
index 975c9a1dc..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/README.md
+++ /dev/null
@@ -1,26 +0,0 @@
-This is a tutorial for the cylinder flap case using FEniCS as a structure solver and OpenFOAM for the Fluid.
-To run it you need:
-- preCICE
-- FEniCS
-- FEniCS Adapter for FSI
-- OpenFOAM + OpenFOAM Adapter (see comments on different OpenFOAM versions below)
-
-# Run it
-
-You can run the tutorial from this directory by typing ```python3 Solid/cyl-flap.py``` in one Terminal and ```bash ./runFluid``` in another.
-
-## Different OpenFOAM versions
-
-* you are using OpenFOAM 5 or older: just use the master branch of this repository together with the master branch of the OpenFOAM Adapter
-* you are using OpenFOAM 6: use the branch called `OpenFOAM6` of this repository together with the branch called `OpenFOAM6` of the OpenFOAM Adapter
-* you are using something else: more version of the OpenFOAM-Adapter are provided as branches of the adapter repository. However, this tutorial has not been tested with other versions of OpenFOAM.
-
-For more information, please refer to [this issue](https://github.com/precice/tutorials/issues/40). Have a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-# Visualize Results
-
-To visualize the results open fluid.foam in paraview. If you want to look at the flap explicitely you can open the ```.pvd``` file in paraview.
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Solid/cyl-flap.py b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Solid/cyl-flap.py
deleted file mode 100644
index 09893e4a5..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Solid/cyl-flap.py
+++ /dev/null
@@ -1,253 +0,0 @@
-# Import required libs
-from fenics import Constant, Function, AutoSubDomain, RectangleMesh, VectorFunctionSpace, interpolate, \
- TrialFunction, TestFunction, Point, Expression, DirichletBC, nabla_grad, \
- Identity, inner, dx, ds, sym, grad, lhs, rhs, dot, File, solve, PointSource, assemble_system
-import dolfin
-
-from ufl import nabla_div
-import numpy as np
-import matplotlib.pyplot as plt
-from fenicsprecice import Adapter
-from enum import Enum
-
-# Beam geometry
-dim = 2 # number of dimensions
-L = 0.35 # length
-H = 0.02 # height
-
-y_bottom = 0.2 - 0.5 * H # y coordinate of bottom surface of beam
-y_top = y_bottom + H # y coordinate of top surface of beam
-x_left = 0.25 # x coordinate of left surface of beam
-x_right = x_left + L # x coordinate of right surface of beam
-
-
-# define the two inside functions to determine the boundaries: clamped Dirichlet and coupling Neumann Boundary
-def left_boundary(x, on_boundary):
- """
- inside-function for the clamped Dirichlet Boundary.
-
- Apply Dirichlet boundary on left part of the beam.
- """
- return on_boundary and abs(x[0] - x_left) < tol # left boundary of beam
-
-
-def remaining_boundary(x, on_boundary):
- """
- inside-function for the coupling Neumann Boundary.
-
- Apply Neumann boundary on top, bottom and right (=remaining) part of the beam.
- """
- return on_boundary and (abs(x[1] - y_top) < tol or # top boundary of beam
- abs(x[1] - y_bottom) < tol or # bottom boundary of beam
- abs(x[0] - x_right) < tol) # right boundary of beam
-
-
-# Numerical properties
-tol = 1E-14
-
-# Beam material properties
-rho = 1000 # density
-E = 5600000.0 # Young's modulus
-nu = 0.4 # Poisson's ratio
-lambda_ = Constant(E * nu / ((1.0 + nu) * (1.0 - 2.0 * nu))) # first Lame constant
-mu = Constant(E / (2.0 * (1.0 + nu))) # second Lame constant
-
-# create Mesh
-n_x_Direction = 20 # DoFs in x direction
-n_y_Direction = 4 # DoFs in y direction
-mesh = RectangleMesh(Point(x_left, y_bottom), Point(x_right, y_top), n_x_Direction, n_y_Direction)
-
-# create Function Space
-V = VectorFunctionSpace(mesh, 'P', 2)
-
-# Trial and Test Functions
-du = TrialFunction(V)
-v = TestFunction(V)
-
-# displacement fields
-u_np1 = Function(V)
-saved_u_old = Function(V)
-
-# function known from previous timestep
-u_n = Function(V)
-v_n = Function(V)
-a_n = Function(V)
-
-# initial value for force and displacement field
-f_N_function = interpolate(Expression(("1", "0"), degree=1), V)
-u_function = interpolate(Expression(("0", "0"), degree=1), V)
-
-# define coupling boundary
-coupling_boundary = AutoSubDomain(remaining_boundary)
-
-# create Adapter
-precice = Adapter(adapter_config_filename="precice-adapter-config-fsi-s.json")
-
-# create subdomains used by the adapter
-clamped_boundary_domain = AutoSubDomain(left_boundary)
-force_boundary = AutoSubDomain(remaining_boundary)
-
-# Initialize the coupling interface
-# Function space V is passed twice as both read and write functions are defined using the same space
-precice_dt = precice.initialize(coupling_boundary, read_function_space=V, write_object=V,
- fixed_boundary=clamped_boundary_domain)
-
-fenics_dt = precice_dt # if fenics_dt == precice_dt, no subcycling is applied
-# fenics_dt = 0.02 # if fenics_dt < precice_dt, subcycling is applied
-dt = Constant(np.min([precice_dt, fenics_dt]))
-
-# generalized alpha method (time stepping) parameters
-alpha_m = Constant(0.2)
-alpha_f = Constant(0.4)
-gamma = Constant(0.5 + alpha_f - alpha_m)
-beta = Constant((gamma + 0.5) ** 2 * 0.25)
-
-# clamp (u == 0) the beam at the left
-bc = DirichletBC(V, Constant((0, 0)), left_boundary)
-
-
-# Define strain
-def epsilon(u):
- return 0.5 * (nabla_grad(u) + nabla_grad(u).T)
-
-
-# Define Stress tensor
-def sigma(u):
- return lambda_ * nabla_div(u) * Identity(dim) + 2 * mu * epsilon(u)
-
-
-# Define Mass form
-def m(u, v):
- return rho * inner(u, v) * dx
-
-
-# Elastic stiffness form
-def k(u, v):
- return inner(sigma(u), sym(grad(v))) * dx
-
-
-def update_acceleration(u, u_old, v_old, a_old, ufl=True):
- if ufl:
- dt_ = dt
- beta_ = beta
- else:
- dt_ = float(dt)
- beta_ = float(beta)
-
- return (u - u_old - dt_ * v_old) / beta / dt_ ** 2 - .5 * (1 - 2 * beta_) / beta_ * a_old
-
-
-def update_velocity(a, u_old, v_old, a_old, ufl=True):
- if ufl:
- dt_ = dt
- gamma_ = gamma
- else:
- dt_ = float(dt)
- gamma_ = float(gamma)
-
- return v_old + dt_ * ((1 - gamma_) * a_old + gamma_ * a)
-
-
-def update_fields(u, u_old, v_old, a_old):
- """Update all fields at the end of a timestep."""
-
- u_vec, u0_vec = u.vector(), u_old.vector()
- v0_vec, a0_vec = v_old.vector(), a_old.vector()
-
- # call update functions
- a_vec = update_acceleration(u_vec, u0_vec, v0_vec, a0_vec, ufl=False)
- v_vec = update_velocity(a_vec, u0_vec, v0_vec, a0_vec, ufl=False)
-
- # assign u->u_old
- v_old.vector()[:], a_old.vector()[:] = v_vec, a_vec
- u_old.vector()[:] = u.vector()
-
-
-def avg(x_old, x_new, alpha):
- return alpha * x_old + (1 - alpha) * x_new
-
-
-# residual
-a_np1 = update_acceleration(du, u_n, v_n, a_n, ufl=True)
-v_np1 = update_velocity(a_np1, u_n, v_n, a_n, ufl=True)
-
-res = m(avg(a_n, a_np1, alpha_m), v) + k(avg(u_n, du, alpha_f), v)
-
-a_form = lhs(res)
-L_form = rhs(res)
-
-# Prepare for time-stepping
-t = 0.0
-n = 0
-time = []
-u_tip = []
-time.append(0.0)
-u_tip.append(0.0)
-E_ext = 0
-
-displacement_out = File("Solid/FSI-S/u_fsi.pvd")
-
-u_n.rename("Displacement", "")
-u_np1.rename("Displacement", "")
-displacement_out << u_n
-
-# time loop for coupling
-while precice.is_coupling_ongoing():
-
- if precice.is_action_required(precice.action_write_iteration_checkpoint()): # write checkpoint
- precice.store_checkpoint(u_n, t, n)
-
- # read data from preCICE and get a new coupling expression
- read_data = precice.read_data()
-
- # Update the point sources on the coupling boundary with the new read data
- Forces_x, Forces_y = precice.get_point_sources(read_data)
-
- A, b = assemble_system(a_form, L_form, bc)
-
- b_forces = b.copy() # b is the same for every iteration, only forces change
-
- for ps in Forces_x:
- ps.apply(b_forces)
- for ps in Forces_y:
- ps.apply(b_forces)
-
- assert (b is not b_forces)
- solve(A, u_np1.vector(), b_forces)
-
- dt = Constant(np.min([precice_dt, fenics_dt]))
-
- # Write new displacements to preCICE
- precice.write_data(u_np1)
-
- # Call to advance coupling, also returns the optimum time step value
- precice_dt = precice.advance(dt(0))
-
- # Either revert to old step if timestep has not converged or move to next timestep
- if precice.is_action_required(precice.action_read_iteration_checkpoint()): # roll back to checkpoint
- u_cp, t_cp, n_cp = precice.retrieve_checkpoint()
- u_n.assign(u_cp)
- t = t_cp
- n = n_cp
- else:
- u_n.assign(u_np1)
- t += float(dt)
- n += 1
-
- if precice.is_time_window_complete():
- update_fields(u_np1, saved_u_old, v_n, a_n)
- if n % 20 == 0:
- displacement_out << (u_n, t)
-
- u_tip.append(u_n(0.6, 0.2)[1])
- time.append(t)
-
-# Plot tip displacement evolution
-displacement_out << u_n
-plt.figure()
-plt.plot(time, u_tip)
-plt.xlabel("Time")
-plt.ylabel("Tip displacement")
-plt.show()
-
-precice.finalize()
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Solid/precice-adapter-config-fsi-s.json b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Solid/precice-adapter-config-fsi-s.json
deleted file mode 100644
index 575bcf3bb..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Solid/precice-adapter-config-fsi-s.json
+++ /dev/null
@@ -1,9 +0,0 @@
-{
- "participant_name": "fenics",
- "config_file_name": "../precice-config.xml",
- "interface": {
- "coupling_mesh_name": "Solid",
- "write_data_name": "Displacements0",
- "read_data_name": "Forces0"
- }
-}
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/precice-config.xml b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/precice-config.xml
deleted file mode 100644
index 5c5b3ca2d..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/precice-config.xml
+++ /dev/null
@@ -1,72 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/removeObsoleteFolders.sh b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/removeObsoleteFolders.sh
deleted file mode 100755
index 80288fe27..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,23 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
-
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/runFluid b/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/runFluid
deleted file mode 100755
index 4c96e7be9..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/runFluid
+++ /dev/null
@@ -1,43 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the "runSolid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- solver=$(getApplication)
-cd ..
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $(getNumberOfProcessors) $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26
-./removeObsoleteFolders.sh
-
-rm -r Fluid/0/
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/.gitignore b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/.gitignore
deleted file mode 100644
index 1528733d2..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/.gitignore
+++ /dev/null
@@ -1,9 +0,0 @@
-Fluid
-!Fluid/0
-!Fluid/0.orig
-!Fluid/constant
-!Fluid/system
-!Fluid/Fluid.foam
-*.vtk
-*.log
-~
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Allclean b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Allclean
deleted file mode 100755
index 90517d679..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Allclean
+++ /dev/null
@@ -1,57 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid (OpenFOAM)
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- rm -rfv 0
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid (deal.II)
-Participant2="Solid"
-cd ./Solid/dealii_output
- # Clean the case
- echo "Cleaning Solid case"
- rm -fv solution-*.vtk
-cd ..
- rm -fv solution-*.vtk
-cd ..
-
-# Remove the log files
-rm -fv ${Participant2}.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-rm -rfv precice-run
-rm -fv .${Participant1}-${Participant2}.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Allrun b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Allrun
deleted file mode 100755
index e6bc2e9dc..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Allrun
+++ /dev/null
@@ -1,107 +0,0 @@
-#!/bin/bash
-
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the script "runFluid" and start the Solid participant manually
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- echo " Restoring 0/ from 0.orig/..."
- rm -rfv 0
- cp -r 0.orig 0
- cd ..
-
- echo " Preparing the mesh..."
- blockMesh -case ${Participant1} > ${Participant1}_blockMesh.log 2>&1
- checkMesh -case ${Participant1} > ${Participant1}_checkMesh.log 2>&1
-
- # get application information
- cd ${Participant1}
- Solver1=$(getApplication) # solver
- echo " ${Participant1} Solver: ${Solver1}."
- cd ..
-
- # Run and get the process id
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-Solver2="nonlinear_elasticity"
-
- # Run
- echo " Starting the ${Participant2} participant..."
- ./runSolid -nonlinear > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
- if [ $parallel -eq 1 ]; then
- echo "Reconstructing fields..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1 &
- fi
-
- # Workaround for issue #26
- echo "Problems with time directories without results? Run the script removeObsoleteFolders.sh and see issue #26 on GitHub."
- # ./removeObsoleteFolders.sh
-
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/U b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/U
deleted file mode 100644
index d5a072d6e..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/U
+++ /dev/null
@@ -1,65 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
-
- cylinder
- {
- type noSlip;
- }
-
- flap
- {
- type movingWallVelocity;
- value uniform (0 0 0);
- }
-
- top
- {
- type noSlip;
- }
-
- bottom
- {
- type noSlip;
- }
-
- inlet
- {
- // Time-varying inlet velocity
- type uniformFixedValue;
- uniformValue table
- (
- ( 0 ( 0 0 0 ) )
- ( 2. ( 2. 0 0 ) )
- ( 100 ( 2. 0 0 ) )
- );
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
deleted file mode 100644
index f4644920d..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
+++ /dev/null
@@ -1,58 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class pointVectorField;
- object pointDisplacement;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 0 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- cylinder
- {
- type fixedValue;
- value $internalField;
- }
- flap
- {
- type fixedValue;
- value $internalField;
- }
-
- top
- {
- type slip;
- }
-
- bottom
- {
- type slip;
- }
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/vorticity b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/vorticity
deleted file mode 100644
index fac7fdf61..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/0.orig/vorticity
+++ /dev/null
@@ -1,64 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- location "0";
- object vorticity;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- cylinder
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- flap
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- inlet
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- top
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- bottom
- {
- type calculated;
- value uniform (0 0 0);
- }
-
- front
- {
- type empty;
- }
- back
- {
- type empty;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/Fluid.foam b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict
deleted file mode 100755
index d323bc059..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict
+++ /dev/null
@@ -1,22 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object dynamicMeshDict;
-}
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dynamicFvMesh dynamicMotionSolverFvMesh;
-
-motionSolverLibs ("libfvMotionSolvers.so");
-
-solver displacementLaplacian;
-
-displacementLaplacianCoeffs {
-
- diffusivity quadratic inverseDistance (flap);
-
-}
\ No newline at end of file
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/transportProperties b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/transportProperties
deleted file mode 100644
index 870a0bb1c..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/transportProperties
+++ /dev/null
@@ -1,14 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location constant;
- object transportProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- transportModel Newtonian;
-
- nu nu [0 2 -1 0 0 0 0 ] 0.001;
- pRef pRef [1 -1 -2 0 0 0 0 ] 0.0;
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/turbulenceProperties b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/turbulenceProperties
deleted file mode 100644
index f906d4153..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/constant/turbulenceProperties
+++ /dev/null
@@ -1,11 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location constant;
- object turbulenceProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-simulationType laminar;
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/blockMeshDict b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/blockMeshDict
deleted file mode 100644
index 24eb36623..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/blockMeshDict
+++ /dev/null
@@ -1,345 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-convertToMeters 1;
-
-// Geometry parameters
-f -0.5; // z-front
-b 0.5; // z-back
-
-// Grid refinement parameters
-H1 13; // Nx first block
-H2 17; // Nx second block
-H3 34; // Nx third block
-H4 65; // Nx last block
-H5 9; // amount of cells above/below flap
-
-V1 13; // Ny first inlet/outlet block
-V2 17; // Ny second inlet block
-V3 10; // Amount of cells in radius
-V4 9; // Ny above/blow flap to back
-V5 14; // Ny top inlet/outlet block
-V6 2; // Ny after flap
-
-GR 2.5; // Circular mesh gradient
-GO 8; // Outlet grading
-
-vertices
-(
- // Block 0
- (0 0 $f) // vertex 0
- (0.119526 0 $f)
- (0.119526 0.119526 $f)
- (0 0.119526 $f) // vertex 3
-
- (0 0 $b) // vertex 4
- (0.119526 0 $b)
- (0.119526 0.119526 $b)
- (0 0.119526 $b) // vertex 7
-
- // Block 1
- (0.280474 0 $f) // vertex 8
- (0.280474 0.119526 $f)
-
- (0.280474 0 $b) // vertex 10
- (0.280474 0.119526 $b)
-
- // Block 2
- (0.6 0 $f) // vertex 12
- (0.6 0.119526 $f)
-
- (0.6 0 $b) // vertex 14
- (0.6 0.119526 $b)
-
- // Block 3
- (2.5 0 $f) // vertex 16
- (2.5 0.119526 $f)
-
- (2.5 0 $b) // vertex 18
- (2.5 0.119526 $b)
-
- // Block 4
- (0.119526 0.280474 $f) // vertex 20
- (0 0.280474 $f)
-
- (0.119526 0.280474 $b) // vertex 22
- (0 0.280474 $b)
-
- // Block 5
- (0.164645 0.164645 $f) // vertex 24
- (0.164656 0.235355 $f)
-
- (0.164645 0.164645 $b) // vertex 26
- (0.164656 0.235355 $b)
-
- // Block 6
- (0.231623 0.16127 $f) // vertex 28
- (0.231623 0.16127 $b)
-
- // Block 7
- (0.299528 0.19 $f) // vertex 30
- (0.24899 0.19 $f)
-
- (0.299528 0.19 $b) // vertex 32
- (0.24899 0.19 $b)
-
- // Block 8
- (0.6 0.19 $f) // vertex 34
- (0.6 0.19 $b)
-
- // Block 9
- (2.5 0.19 $f) // vertex 36
- (2.5 0.19 $b)
-
- // Block 10
- (0.280474 0.280474 $f) // vertex 38
- (0.231623 0.238730 $f)
-
- (0.280474 0.280474 $b) // vertex 40
- (0.231623 0.238730 $b)
-
- // Block 11
- (0.299528 0.21 $f) // vertex 42
- (0.24899 0.21 $f)
-
- (0.299528 0.21 $b) // vertex 44
- (0.24899 0.21 $b)
-
- // Block 12
- (0.6 0.21 $f) // vertex 46
- (0.6 0.280474 $f)
-
- (0.6 0.21 $b) // vertex 48
- (0.6 0.280474 $b)
-
- // Block 14
- (2.5 0.21 $f) // vertex 50
- (2.5 0.280474 $f)
-
- (2.5 0.21 $b) // vertex 52
- (2.5 0.280474 $b)
-
- // Block 15
- (0.119526 0.41 $f) // vertex 54
- (0 0.41 $f)
-
- (0.119526 0.41 $b) // vertex 56
- (0 0.41 $b)
-
- // Block 16
- (0.280474 0.41 $f) // vertex 58
- (0.280474 0.41 $b)
-
- // Block 17
- (0.6 0.41 $f) // vertex 60
- (0.6 0.41 $b)
-
- // Block 18
- (2.5 0.41 $f) // vertex 62
- (2.5 0.41 $b)
-);
-
-
-blocks
-(
- // Block 0 - 4
- hex ( 0 1 2 3 4 5 6 7) ($H1 $V1 1) simpleGrading (1 1 1)
- hex ( 1 8 9 2 5 10 11 6) ($H2 $V1 1) simpleGrading (1 1 1)
- hex ( 8 12 13 9 10 14 15 11) ($H3 $V1 1) simpleGrading (1 1 1)
- hex (12 16 17 13 14 18 19 15) ($H4 $V1 1) simpleGrading ($GO 1 1)
- hex ( 3 2 20 21 7 6 22 23) ($H1 $V2 1) simpleGrading (1 1 1)
-
- // Block 5 - 9
- hex (24 25 20 2 26 27 22 6) ($H2 $V3 1) simpleGrading (1 $GR 1)
- hex (28 24 2 9 29 26 6 11) ($H2 $V3 1) simpleGrading (1 $GR 1)
- hex (31 28 9 30 33 29 11 32) ($H5 $V3 1) simpleGrading (1 $GR 1)
- hex ( 9 13 34 30 11 15 35 32) ($H3 $V4 1) simpleGrading (1 1 1)
- hex (13 17 36 34 15 19 37 35) ($H4 $V4 1) simpleGrading ($GO 1 1)
-
- // Block 10 - 14
- hex (25 39 38 20 27 41 40 22) ($H2 $V3 1) simpleGrading (1 $GR 1)
- hex (39 43 42 38 41 45 44 40) ($H5 $V3 1) simpleGrading (1 $GR 1)
- hex (42 46 47 38 44 48 49 40) ($H3 $V4 1) simpleGrading (1 1 1)
- hex (34 36 50 46 35 37 52 48) ($H4 $V6 1) simpleGrading ($GO 1 1)
- hex (46 50 51 47 48 52 53 49) ($H4 $V4 1) simpleGrading ($GO 1 1)
-
- // Block 15 - 18
- hex (21 20 54 55 23 22 56 57) ($H1 $V5 1) simpleGrading (1 1 1)
- hex (20 38 58 54 22 40 59 56) ($H2 $V5 1) simpleGrading (1 1 1)
- hex (38 47 60 58 40 49 61 59) ($H3 $V5 1) simpleGrading (1 1 1)
- hex (47 51 62 60 49 53 63 61) ($H4 $V5 1) simpleGrading ($GO 1 1)
-);
-
-edges
-(
- arc 9 2 (0.2 0.1 $f) // Block 1
- arc 11 6 (0.2 0.1 $b)
-
- arc 2 20 (0.1 0.2 $f) // Block 4
- arc 6 22 (0.1 0.2 $b)
-
- arc 24 25 (0.15 0.2 $f) // Block 5
- arc 26 27 (0.15 0.2 $b)
-
- arc 24 28 (0.2 0.15 $f) // Block 6
- arc 26 29 (0.2 0.15 $b)
-
- arc 9 30 (0.293144 0.156475 $f) // Block 7
- arc 28 31 (0.243369 0.175117 $f)
- arc 11 32 (0.293144 0.156475 $b) // Block 7
- arc 29 33 (0.243369 0.175117 $b)
-
- arc 20 38 (0.2 0.3 $f) // Block 10
- arc 25 39 (0.2 0.25 $f)
- arc 22 40 (0.2 0.3 $b) // Block 10
- arc 27 41 (0.2 0.25 $b)
-
- arc 39 43 (0.24092 0.228733 $f) // Block 11
- arc 41 45 (0.24092 0.228733 $b)
- arc 38 42 (0.291756 0.248208 $f) // Block 11
- arc 40 44 (0.291756 0.248208 $b)
-);
-
-boundary
-(
- front
- {
- type empty;
- faces
- (
- (0 1 2 3)
- (3 2 20 21)
- (21 20 55 54)
- (1 8 9 2)
- (2 9 28 24)
- (2 24 25 20)
- (25 39 38 20)
- (20 38 58 54)
- (9 30 31 28)
- (43 42 38 39)
- (8 12 13 9)
- (9 13 34 30)
- (42 46 47 38)
- (38 47 60 58)
- (12 16 17 13)
- (13 17 36 34)
- (34 36 50 46)
- (46 50 51 47)
- (47 51 62 60)
- );
- }
-
- back
- {
- type empty;
- faces
- (
- (4 5 6 7)
- (7 6 22 23)
- (23 22 56 57)
- (5 10 11 6)
- (6 11 29 26)
- (6 26 27 22)
- (27 41 40 22)
- (22 40 59 56)
- (11 32 33 29)
- (45 44 40 41)
- (10 14 15 11)
- (11 15 35 32)
- (44 48 49 40)
- (40 49 61 59)
- (14 18 19 15)
- (15 19 37 35)
- (35 37 52 48)
- (48 52 53 49)
- (49 53 63 61)
- );
- }
-
- inlet
- {
- type patch;
- faces
- (
- ( 0 4 7 3)
- ( 3 7 23 21)
- (21 23 57 55)
- );
- }
-
- outlet
- {
- type patch;
- faces
- (
- (16 18 19 17)
- (17 19 37 36)
- (36 37 52 50)
- (50 52 53 51)
- (51 53 63 62)
- );
- }
-
- top
- {
- type wall;
- faces
- (
- (55 54 56 57)
- (54 58 59 56)
- (58 60 61 59)
- (60 62 63 61)
- );
- }
-
- bottom
- {
- type wall;
- faces
- (
- (0 1 5 4)
- (1 8 10 5)
- (8 12 14 10)
- (12 16 18 14)
- );
- }
-
- flap
- {
- type wall;
- faces
- (
- (31 30 32 33)
- (30 34 35 32)
- (34 35 48 46)
- (42 46 48 44)
- (43 42 44 45)
- );
- }
-
- cylinder
- {
- type wall;
- faces
- (
- (24 28 29 26)
- (28 31 33 29)
- (43 39 41 45)
- (39 25 27 41)
- (25 24 26 27)
- );
- }
-);
-
-mergePatchPairs
-(
-);
-
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/fvSchemes b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/fvSchemes
deleted file mode 100644
index b2d960d05..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/fvSchemes
+++ /dev/null
@@ -1,53 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSchemes;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- ddtSchemes
- {
- default backward;
- }
-
- gradSchemes
- {
- default Gauss linear;
- }
-
- divSchemes
- {
- default none;
- div(phi,U) bounded Gauss linearUpwind limited;
- div((nuEff*dev2(T(grad(U))))) Gauss linear;
- }
-
- interpolationSchemes
- {
- default linear;
- }
-
- laplacianSchemes
- {
- default Gauss linear corrected;
- }
-
- snGradSchemes
- {
- default corrected;
- }
-
- wallDist
- {
- method meshWave;
- }
-
- fluxRequired
- {
- default no;
- p ;
- Phi ;
- }
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/fvSolution b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/fvSolution
deleted file mode 100644
index 886a252ec..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/fvSolution
+++ /dev/null
@@ -1,97 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSolution;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-solvers
-{
- p
- {
- solver GAMG;
- tolerance 1e-10;
- relTol 1e-6;
- smoother DICGaussSeidel;
- }
-
- pFinal
- {
- $p;
- relTol 0;
- }
-
- pcorrFinal
- {
- $p;
- relTol 0;
- }
-
- Phi
- {
- $p;
- }
-
- "(U|cellDisplacement)"
- {
- solver smoothSolver;
- smoother symGaussSeidel;
- tolerance 1e-10;
- relTol 1e-6;
- }
-
- "(U|cellDisplacement)Final"
- {
- $U;
- relTol 0;
- }
-}
-
-PIMPLE
-{
- nCorrectors 2;
- nNonOrthogonalCorrectors 0;
- tolerance 1.0e-14;
- relTol 5e-3;
- pisoTol 1e-6;
- consistent true;
-
- nOuterCorrectors 50;
-
- // OpenFOAM (.com), OpenFOAM 5 or older (.org)
- /*
- residualControl
- {
- U
- {
- tolerance 5e-5;
- relTol 0;
- }
- p
- {
- tolerance 5e-4;
- relTol 0;
- }
- }
- */
-
- // OpenFOAM 6 (.org) or newer
- /*
- residualControl
- {
- U 5e-5;
- p 5e-4;
- }
- */
-}
-
-potentialFlow
-{
- nNonOrthogonalCorrectors 5;
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/README.md b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/README.md
deleted file mode 100644
index 08eccd3f7..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/README.md
+++ /dev/null
@@ -1,20 +0,0 @@
-# Tutorial for an FSI simulation of a cylinder-flap scenario
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM). Have also a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-You may run the coupled simulation in serial using the script `Allrun` or (OpenFOAM) in parallel with `Allrun -parallel`. The output of each step will be redirected to log files. You can cleanup the simulation using `Allclean`.
-
-If you prefer to run the two simulations in two different terminals and watch their output on the screen, use the (simpler) scripts `runFluid` (or `runFluid -parallel`).
-
-Before starting the deal.II program, it needs to be compiled and copied in this case directory. Information about building is collected in the [deal.II wiki](https://github.com/precice/dealii-adapter/wiki/Building). You can use the following command to run e.g. the nonlinear deal.II solver afterwards:
-```
-./runSolid -nonlinear
-```
-
-There is an [open issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. Please run the script `removeObsoleteSolvers.sh` to delete the additional files.
-
-You may adjust the end time in the precice-config_*.xml, or interupt the execution earlier if you want.
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Solid/linear_elasticity.prm b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Solid/linear_elasticity.prm
deleted file mode 100644
index b71f48598..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Solid/linear_elasticity.prm
+++ /dev/null
@@ -1,68 +0,0 @@
-# Listing of Parameters
-# Dimensional quantities are in SI units
-# --------------------------------------
-
-subsection Time
- # End time
- set End time = 15
-
- # Time step size
- set Time step size = 0.002
-
- # Write results every x timesteps
- set Output interval = 100
-end
-
-subsection Discretization
- # Time integration scheme
- # 0 = forward, 1 = backward
- set theta = 0.5
-
- # Polynomial degree of the FE system
- set Polynomial degree = 4
-end
-
-subsection System properties
- # mu (shear modulus)
- set mu = 2e6
-
- # lambda
- set lambda = 8e6
-
- # density
- set rho = 1000
-
- # body forces x,y,z
- set body forces = 0.0,0.0,0.0
-end
-
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
-
- # Linear solver: CG or Direct
- set Solver type = Direct
-end
-
-subsection precice configuration
- # Cases: FSI3 or PF for perpendicular flap
- set Scenario = FSI3
-
- # Name of the precice configuration file
- set precice config-file = precice-config.xml
-
- # Name of the participant in the precice-config.xml file
- set Participant name = Solid
-
- # Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
-
- # Name of the read data in the precice-config.xml file
- set Read data name = Stress
-
- # Name of the write data in the precice-config.xml file
- set Write data name = Displacement
-end
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/precice-config.xml b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/precice-config.xml
deleted file mode 100644
index e9752efed..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/precice-config.xml
+++ /dev/null
@@ -1,82 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/removeObsoleteFolders.sh b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/removeObsoleteFolders.sh
deleted file mode 100755
index 6866c8c42..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,22 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/runFluid b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/runFluid
deleted file mode 100755
index 3223006a0..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/runFluid
+++ /dev/null
@@ -1,42 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the execute the coupled_elasto_dynamics bindary
-# in another terminal.
-# These scripts present how the two participants would be started manually.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- solver=$(getApplication)
- procs=$(getNumberOfProcessors)
-cd ..
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $procs $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26 (OF-adapter, relevant for OF .com versions)
-./removeObsoleteFolders.sh
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/runSolid b/FSI/cylinderFlap_2D/OpenFOAM-deal.II/runSolid
deleted file mode 100755
index 7e6fe12c3..000000000
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/runSolid
+++ /dev/null
@@ -1,27 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-
-# Solid participant
-
-# Run this script in one terminal and the execute the Fluid participant
-# in another terminal.
-# These scripts present how the two participants would be started manually.
-
-# 1 for true, 0 for false
-nonlinear=0
-if [ "$1" = "-nonlinear" ]; then
- nonlinear=1
-fi
-
-linear=0
-if [ "$1" = "-linear" ]; then
- linear=1
-fi
-
-if [ $linear -eq 1 ]; then
- ./linear_elasticity Solid/linear_elasticity.prm
-elif [ $nonlinear -eq 1 ]; then
- ./nonlinear_elasticity Solid/nonlinear_elasticity.prm
-else
- echo "No solver type specified. Please specify -linear or -nonlinear as solver type"
-fi
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Allclean b/FSI/flap_perp/OpenFOAM-CalculiX/Allclean
deleted file mode 100755
index 785470459..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Allclean
+++ /dev/null
@@ -1,62 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- rm -rfv 0
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_potentialFoam.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid
-Participant2="Solid"
-cd ${Participant2}
- # Clean the case
- rm -fv *.log
- rm -fv flap.cvg
- rm -fv flap.dat
- rm -fv flap.frd
- rm -fv flap.sta
- rm -fv flap.12d
-cd ..
-# Remove the log files
-rm -fv spooles.out
-rm -fv ${Participant2}.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-postProcessingInfo.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Allrun b/FSI/flap_perp/OpenFOAM-CalculiX/Allrun
deleted file mode 100755
index 3af06ceab..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Allrun
+++ /dev/null
@@ -1,120 +0,0 @@
-#!/bin/bash
-
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the scripts "runSolid" and "runFluid"
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- echo " Restoring 0/ from 0.orig/..."
- rm -rfv 0
- cp -r 0.orig 0
- cd ..
-
- echo " Preparing the mesh..."
- blockMesh -case ${Participant1} > ${Participant1}_blockMesh.log 2>&1
- checkMesh -case ${Participant1} > ${Participant1}_checkMesh.log 2>&1
-
- # Initialize the internal field with a potential flow
- potentialFoam -case ${Participant1} > ${Participant1}_potentialFoam.log 2>&1
-
- # get application information
- cd ${Participant1}
- Solver1=$(getApplication) # solver
- echo " ${Participant1} Solver: ${Solver1}."
- cd ..
-
- # Run and get the process id
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-Solver2="ccx_preCICE"
-
- # You can use CalculiX CGX to setup the structural simulation from sratch.
- # This will re-generate the all.msh, fix1_beam.nam, interface_beam.nam files.
- #
- # # Prepare in silent mode
- # echo "Preparing the ${Participant2} participant..."
- # cd ${Participant2}
- # echo " Executing cgx (provided by CalculiX, make sure this exists)..."
- # cgx -bg pre_flap.fbd > prepare_flap.log 2>&1
- # cd ..
-
- # Run
- echo " Starting the ${Participant2} participant..."
- ${Solver2} -i ${Participant2}/flap -precice-participant Calculix > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
- if [ $parallel -eq 1 ]; then
- echo "Reconstructing fields..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1 &
- fi
-
- # Workaround for issue #26
- echo "Problems with time directories without results? Run the script removeObsoleteFolders.sh and see issue #26 on GitHub."
- # ./removeObsoleteFolders.sh
-
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Allrun_parallel b/FSI/flap_perp/OpenFOAM-CalculiX/Allrun_parallel
deleted file mode 100755
index e333301db..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Allrun_parallel
+++ /dev/null
@@ -1 +0,0 @@
-./Allrun -parallel
\ No newline at end of file
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/Fluid.foam b/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/blockMeshDict b/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/blockMeshDict
deleted file mode 100644
index 3ffc25916..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/blockMeshDict
+++ /dev/null
@@ -1,153 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-scale 1.;
-
-x0 -3.;
-x1 -0.05;
-x2 0.05;
-x3 3.;
-
-z0 0.;
-z1 1.;
-z2 4.;
-
-w 0.3;
-
-vertices
-(
- ($x0 $w $z0) // 0
- ($x1 $w $z0) // 1
- ($x2 $w $z0) // 2
- ($x3 $w $z0) // 3
- ($x0 $w $z1) // 4
- ($x1 $w $z1) // 5
- ($x2 $w $z1) // 6
- ($x3 $w $z1) // 7
- ($x0 $w $z2) // 8
- ($x1 $w $z2) // 9
- ($x2 $w $z2) // 10
- ($x3 $w $z2) // 11
-
- ($x0 0.0 $z0) // 12
- ($x1 0.0 $z0) // 13
- ($x2 0.0 $z0) // 14
- ($x3 0.0 $z0) // 15
- ($x0 0.0 $z1) // 16
- ($x1 0.0 $z1) // 17
- ($x2 0.0 $z1) // 18
- ($x3 0.0 $z1) // 19
- ($x0 0.0 $z2) // 20
- ($x1 0.0 $z2) // 21
- ($x2 0.0 $z2) // 22
- ($x3 0.0 $z2) // 23
-);
-
-// Grading
-h1 30;
-h2 3;
-v1 15;
-v2 30;
-
-blocks
-(
- hex ( 0 1 5 4 12 13 17 16 )
- ($h1 $v1 1 )
- simpleGrading (0.5 1 1)
-
- hex ( 2 3 7 6 14 15 19 18 )
- ($h1 $v1 1)
- simpleGrading (2 1 1)
-
- hex ( 4 5 9 8 16 17 21 20 )
- ($h1 $v2 1)
- simpleGrading (0.5 2 1)
-
- hex ( 5 6 10 9 17 18 22 21 )
- ($h2 $v2 1)
- simpleGrading (1 2 1)
-
- hex ( 6 7 11 10 18 19 23 22 )
- ($h1 $v2 1 )
- simpleGrading (2 2 1)
-);
-
-edges
-(
-);
-
-boundary
-(
- inlet
- {
- type patch;
- faces
- (
- ( 0 4 16 12 )
- ( 4 8 20 16 )
- );
- }
- outlet
- {
- type patch;
- faces
- (
- ( 3 7 19 15 )
- ( 7 11 23 19 )
- );
- }
- flap
- {
- type wall;
- faces
- (
- ( 1 5 17 13 )
- ( 5 6 18 17 )
- ( 6 2 14 18 )
- );
- }
- upperWall
- {
- type wall;
- faces
- (
- ( 8 9 21 20 )
- ( 9 10 22 21 )
- ( 10 11 23 22 )
- );
- }
- lowerWall
- {
- type wall;
- faces
- (
- ( 0 1 13 12 )
- ( 2 3 15 14 )
- );
- }
- frontAndBack
- {
- type empty;
- faces
- (
- ( 0 1 5 4 )
- ( 2 3 7 6 )
- ( 4 5 9 8 )
- ( 5 6 10 9 )
- ( 6 7 11 10 )
- ( 12 13 17 16 )
- ( 14 15 19 18 )
- ( 16 17 21 20 )
- ( 17 18 22 21 )
- ( 18 19 23 22 )
- );
- }
-);
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/decomposeParDict b/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/decomposeParDict
deleted file mode 100644
index 1350cc23e..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/decomposeParDict
+++ /dev/null
@@ -1,24 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location system;
- object decomposeParDict;
-}
-
- numberOfSubdomains 6;
-
- method hierarchical;
- hierarchicalCoeffs
- {
- n (3 2 1);
- delta 0.001;
- order xyz;
- }
-
- distributed false;
- roots
- (
- );
-
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/displacementProbe b/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/displacementProbe
deleted file mode 100644
index 2bad5f4af..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/displacementProbe
+++ /dev/null
@@ -1,18 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-Description
- Writes out values of fields from cells nearest to specified locations.
-
-\*---------------------------------------------------------------------------*/
-
-#includeEtc "caseDicts/postProcessing/probes/probes.cfg"
-type probes;
-probeLocations
-(
- (0 0.15 1.0)
-);
-fields
-(
- cellDisplacement
-);
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/preciceDict b/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/preciceDict
deleted file mode 100644
index f5b1fd303..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/preciceDict
+++ /dev/null
@@ -1,54 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object preciceDict;
-}
-
-preciceConfig "precice-config.xml";
-
-participant Fluid;
-
-modules (FSI);
-
-interfaces
-{
- Interface1
- {
- mesh Fluid-Mesh-Faces;
- patches (flap);
- locations faceCenters;
-
- readData
- (
- );
-
- writeData
- (
- Forces0
- );
- };
-
- Interface2
- {
- mesh Fluid-Mesh-Nodes;
- patches (flap);
- locations faceNodes;
-
- readData
- (
- Displacements0
- );
-
- writeData
- (
- );
- };
-};
-
-FSI
-{
- rho rho [1 -3 0 0 0 0 0] 1;
-}
\ No newline at end of file
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/README.md b/FSI/flap_perp/OpenFOAM-CalculiX/README.md
deleted file mode 100644
index 288d8b174..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/README.md
+++ /dev/null
@@ -1,19 +0,0 @@
-# Tutorial for an FSI simulation of an elastic flap perpendicular to a channel flow
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-OpenFOAM-and-CalculiX).
-
-The case files are prepared for the latest versions of OpenFOAM and use the solver `pimpleFoam`. **In case you are using a previous OpenFOAM version** you need to adjust the solver to `pimpleDyMFoam` in the `Fluid/system/controlDict` file. Have a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-You may run the coupled simulation in serial using the script `Allrun` or in parallel with `Allrun -parallel` (`Allrun_parallel` is a shortcut to this). The output of each step will be redirected to log files. You can cleanup the simulation using `Allclean`.
-
-If you prefer to run the two simulations in two different terminals and watch their output on the screen, use the (simpler) scripts `runFluid` (or `runFluid -parallel`) and `runSolid`. Please always run the script `runFluid` first.
-
-There is an [open issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. Please run the script `removeObsoleteSolvers.sh` to delete the additional files.
-
-You may adjust the end time in the precice-config_*.xml, or interupt the execution earlier if you want.
-
-This case was contributed by Derek Risseeuw (TU Delft).
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/all.msh b/FSI/flap_perp/OpenFOAM-CalculiX/Solid/all.msh
deleted file mode 100644
index 71ac36c2b..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/all.msh
+++ /dev/null
@@ -1,168 +0,0 @@
-*NODE, NSET=Nall
- 1,5.000000000000e-02,0.000000000000e+00,0.000000000000e+00
- 2,0.000000000000e+00,0.000000000000e+00,0.000000000000e+00
- 3,0.000000000000e+00,0.000000000000e+00,5.000000000000e-02
- 4,5.000000000000e-02,0.000000000000e+00,5.000000000000e-02
- 5,5.000000000000e-02,3.000000000000e-01,0.000000000000e+00
- 6,0.000000000000e+00,3.000000000000e-01,0.000000000000e+00
- 7,0.000000000000e+00,3.000000000000e-01,5.000000000000e-02
- 8,5.000000000000e-02,3.000000000000e-01,5.000000000000e-02
- 9,0.000000000000e+00,0.000000000000e+00,1.000000000000e-01
- 10,5.000000000000e-02,0.000000000000e+00,1.000000000000e-01
- 11,0.000000000000e+00,3.000000000000e-01,1.000000000000e-01
- 12,5.000000000000e-02,3.000000000000e-01,1.000000000000e-01
- 13,0.000000000000e+00,0.000000000000e+00,1.500000000000e-01
- 14,5.000000000000e-02,0.000000000000e+00,1.500000000000e-01
- 15,0.000000000000e+00,3.000000000000e-01,1.500000000000e-01
- 16,5.000000000000e-02,3.000000000000e-01,1.500000000000e-01
- 17,0.000000000000e+00,0.000000000000e+00,2.000000000000e-01
- 18,5.000000000000e-02,0.000000000000e+00,2.000000000000e-01
- 19,0.000000000000e+00,3.000000000000e-01,2.000000000000e-01
- 20,5.000000000000e-02,3.000000000000e-01,2.000000000000e-01
- 21,0.000000000000e+00,0.000000000000e+00,2.500000000000e-01
- 22,5.000000000000e-02,0.000000000000e+00,2.500000000000e-01
- 23,0.000000000000e+00,3.000000000000e-01,2.500000000000e-01
- 24,5.000000000000e-02,3.000000000000e-01,2.500000000000e-01
- 25,0.000000000000e+00,0.000000000000e+00,3.000000000000e-01
- 26,5.000000000000e-02,0.000000000000e+00,3.000000000000e-01
- 27,0.000000000000e+00,3.000000000000e-01,3.000000000000e-01
- 28,5.000000000000e-02,3.000000000000e-01,3.000000000000e-01
- 29,0.000000000000e+00,0.000000000000e+00,3.500000000000e-01
- 30,5.000000000000e-02,0.000000000000e+00,3.500000000000e-01
- 31,0.000000000000e+00,3.000000000000e-01,3.500000000000e-01
- 32,5.000000000000e-02,3.000000000000e-01,3.500000000000e-01
- 33,0.000000000000e+00,0.000000000000e+00,4.000000000000e-01
- 34,5.000000000000e-02,0.000000000000e+00,4.000000000000e-01
- 35,0.000000000000e+00,3.000000000000e-01,4.000000000000e-01
- 36,5.000000000000e-02,3.000000000000e-01,4.000000000000e-01
- 37,0.000000000000e+00,0.000000000000e+00,4.500000000000e-01
- 38,5.000000000000e-02,0.000000000000e+00,4.500000000000e-01
- 39,0.000000000000e+00,3.000000000000e-01,4.500000000000e-01
- 40,5.000000000000e-02,3.000000000000e-01,4.500000000000e-01
- 41,0.000000000000e+00,0.000000000000e+00,5.000000000000e-01
- 42,5.000000000000e-02,0.000000000000e+00,5.000000000000e-01
- 43,0.000000000000e+00,3.000000000000e-01,5.000000000000e-01
- 44,5.000000000000e-02,3.000000000000e-01,5.000000000000e-01
- 45,0.000000000000e+00,0.000000000000e+00,5.500000000000e-01
- 46,5.000000000000e-02,0.000000000000e+00,5.500000000000e-01
- 47,0.000000000000e+00,3.000000000000e-01,5.500000000000e-01
- 48,5.000000000000e-02,3.000000000000e-01,5.500000000000e-01
- 49,0.000000000000e+00,0.000000000000e+00,6.000000000000e-01
- 50,5.000000000000e-02,0.000000000000e+00,6.000000000000e-01
- 51,0.000000000000e+00,3.000000000000e-01,6.000000000000e-01
- 52,5.000000000000e-02,3.000000000000e-01,6.000000000000e-01
- 53,0.000000000000e+00,0.000000000000e+00,6.500000000000e-01
- 54,5.000000000000e-02,0.000000000000e+00,6.500000000000e-01
- 55,0.000000000000e+00,3.000000000000e-01,6.500000000000e-01
- 56,5.000000000000e-02,3.000000000000e-01,6.500000000000e-01
- 57,0.000000000000e+00,0.000000000000e+00,7.000000000000e-01
- 58,5.000000000000e-02,0.000000000000e+00,7.000000000000e-01
- 59,0.000000000000e+00,3.000000000000e-01,7.000000000000e-01
- 60,5.000000000000e-02,3.000000000000e-01,7.000000000000e-01
- 61,0.000000000000e+00,0.000000000000e+00,7.500000000000e-01
- 62,5.000000000000e-02,0.000000000000e+00,7.500000000000e-01
- 63,0.000000000000e+00,3.000000000000e-01,7.500000000000e-01
- 64,5.000000000000e-02,3.000000000000e-01,7.500000000000e-01
- 65,0.000000000000e+00,0.000000000000e+00,8.000000000000e-01
- 66,5.000000000000e-02,0.000000000000e+00,8.000000000000e-01
- 67,0.000000000000e+00,3.000000000000e-01,8.000000000000e-01
- 68,5.000000000000e-02,3.000000000000e-01,8.000000000000e-01
- 69,0.000000000000e+00,0.000000000000e+00,8.500000000000e-01
- 70,5.000000000000e-02,0.000000000000e+00,8.500000000000e-01
- 71,0.000000000000e+00,3.000000000000e-01,8.500000000000e-01
- 72,5.000000000000e-02,3.000000000000e-01,8.500000000000e-01
- 73,0.000000000000e+00,0.000000000000e+00,9.000000000000e-01
- 74,5.000000000000e-02,0.000000000000e+00,9.000000000000e-01
- 75,0.000000000000e+00,3.000000000000e-01,9.000000000000e-01
- 76,5.000000000000e-02,3.000000000000e-01,9.000000000000e-01
- 77,0.000000000000e+00,0.000000000000e+00,9.500000000000e-01
- 78,5.000000000000e-02,0.000000000000e+00,9.500000000000e-01
- 79,0.000000000000e+00,3.000000000000e-01,9.500000000000e-01
- 80,5.000000000000e-02,3.000000000000e-01,9.500000000000e-01
- 81,0.000000000000e+00,0.000000000000e+00,1.000000000000e+00
- 82,5.000000000000e-02,0.000000000000e+00,1.000000000000e+00
- 83,0.000000000000e+00,3.000000000000e-01,1.000000000000e+00
- 84,5.000000000000e-02,3.000000000000e-01,1.000000000000e+00
- 85,-5.000000000000e-02,0.000000000000e+00,0.000000000000e+00
- 86,-5.000000000000e-02,0.000000000000e+00,5.000000000000e-02
- 87,-5.000000000000e-02,3.000000000000e-01,0.000000000000e+00
- 88,-5.000000000000e-02,3.000000000000e-01,5.000000000000e-02
- 89,-5.000000000000e-02,0.000000000000e+00,1.000000000000e-01
- 90,-5.000000000000e-02,3.000000000000e-01,1.000000000000e-01
- 91,-5.000000000000e-02,0.000000000000e+00,1.500000000000e-01
- 92,-5.000000000000e-02,3.000000000000e-01,1.500000000000e-01
- 93,-5.000000000000e-02,0.000000000000e+00,2.000000000000e-01
- 94,-5.000000000000e-02,3.000000000000e-01,2.000000000000e-01
- 95,-5.000000000000e-02,0.000000000000e+00,2.500000000000e-01
- 96,-5.000000000000e-02,3.000000000000e-01,2.500000000000e-01
- 97,-5.000000000000e-02,0.000000000000e+00,3.000000000000e-01
- 98,-5.000000000000e-02,3.000000000000e-01,3.000000000000e-01
- 99,-5.000000000000e-02,0.000000000000e+00,3.500000000000e-01
- 100,-5.000000000000e-02,3.000000000000e-01,3.500000000000e-01
- 101,-5.000000000000e-02,0.000000000000e+00,4.000000000000e-01
- 102,-5.000000000000e-02,3.000000000000e-01,4.000000000000e-01
- 103,-5.000000000000e-02,0.000000000000e+00,4.500000000000e-01
- 104,-5.000000000000e-02,3.000000000000e-01,4.500000000000e-01
- 105,-5.000000000000e-02,0.000000000000e+00,5.000000000000e-01
- 106,-5.000000000000e-02,3.000000000000e-01,5.000000000000e-01
- 107,-5.000000000000e-02,0.000000000000e+00,5.500000000000e-01
- 108,-5.000000000000e-02,3.000000000000e-01,5.500000000000e-01
- 109,-5.000000000000e-02,0.000000000000e+00,6.000000000000e-01
- 110,-5.000000000000e-02,3.000000000000e-01,6.000000000000e-01
- 111,-5.000000000000e-02,0.000000000000e+00,6.500000000000e-01
- 112,-5.000000000000e-02,3.000000000000e-01,6.500000000000e-01
- 113,-5.000000000000e-02,0.000000000000e+00,7.000000000000e-01
- 114,-5.000000000000e-02,3.000000000000e-01,7.000000000000e-01
- 115,-5.000000000000e-02,0.000000000000e+00,7.500000000000e-01
- 116,-5.000000000000e-02,3.000000000000e-01,7.500000000000e-01
- 117,-5.000000000000e-02,0.000000000000e+00,8.000000000000e-01
- 118,-5.000000000000e-02,3.000000000000e-01,8.000000000000e-01
- 119,-5.000000000000e-02,0.000000000000e+00,8.500000000000e-01
- 120,-5.000000000000e-02,3.000000000000e-01,8.500000000000e-01
- 121,-5.000000000000e-02,0.000000000000e+00,9.000000000000e-01
- 122,-5.000000000000e-02,3.000000000000e-01,9.000000000000e-01
- 123,-5.000000000000e-02,0.000000000000e+00,9.500000000000e-01
- 124,-5.000000000000e-02,3.000000000000e-01,9.500000000000e-01
- 125,-5.000000000000e-02,0.000000000000e+00,1.000000000000e+00
- 126,-5.000000000000e-02,3.000000000000e-01,1.000000000000e+00
-*ELEMENT, TYPE=C3D8, ELSET=Eall
- 1, 1, 2, 3, 4, 5, 6, 7, 8
- 2, 4, 3, 9, 10, 8, 7, 11, 12
- 3, 10, 9, 13, 14, 12, 11, 15, 16
- 4, 14, 13, 17, 18, 16, 15, 19, 20
- 5, 18, 17, 21, 22, 20, 19, 23, 24
- 6, 22, 21, 25, 26, 24, 23, 27, 28
- 7, 26, 25, 29, 30, 28, 27, 31, 32
- 8, 30, 29, 33, 34, 32, 31, 35, 36
- 9, 34, 33, 37, 38, 36, 35, 39, 40
- 10, 38, 37, 41, 42, 40, 39, 43, 44
- 11, 42, 41, 45, 46, 44, 43, 47, 48
- 12, 46, 45, 49, 50, 48, 47, 51, 52
- 13, 50, 49, 53, 54, 52, 51, 55, 56
- 14, 54, 53, 57, 58, 56, 55, 59, 60
- 15, 58, 57, 61, 62, 60, 59, 63, 64
- 16, 62, 61, 65, 66, 64, 63, 67, 68
- 17, 66, 65, 69, 70, 68, 67, 71, 72
- 18, 70, 69, 73, 74, 72, 71, 75, 76
- 19, 74, 73, 77, 78, 76, 75, 79, 80
- 20, 78, 77, 81, 82, 80, 79, 83, 84
- 21, 2, 85, 86, 3, 6, 87, 88, 7
- 22, 3, 86, 89, 9, 7, 88, 90, 11
- 23, 9, 89, 91, 13, 11, 90, 92, 15
- 24, 13, 91, 93, 17, 15, 92, 94, 19
- 25, 17, 93, 95, 21, 19, 94, 96, 23
- 26, 21, 95, 97, 25, 23, 96, 98, 27
- 27, 25, 97, 99, 29, 27, 98, 100, 31
- 28, 29, 99, 101, 33, 31, 100, 102, 35
- 29, 33, 101, 103, 37, 35, 102, 104, 39
- 30, 37, 103, 105, 41, 39, 104, 106, 43
- 31, 41, 105, 107, 45, 43, 106, 108, 47
- 32, 45, 107, 109, 49, 47, 108, 110, 51
- 33, 49, 109, 111, 53, 51, 110, 112, 55
- 34, 53, 111, 113, 57, 55, 112, 114, 59
- 35, 57, 113, 115, 61, 59, 114, 116, 63
- 36, 61, 115, 117, 65, 63, 116, 118, 67
- 37, 65, 117, 119, 69, 67, 118, 120, 71
- 38, 69, 119, 121, 73, 71, 120, 122, 75
- 39, 73, 121, 123, 77, 75, 122, 124, 79
- 40, 77, 123, 125, 81, 79, 124, 126, 83
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/flap.inp b/FSI/flap_perp/OpenFOAM-CalculiX/Solid/flap.inp
deleted file mode 100644
index 3357ecc72..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/flap.inp
+++ /dev/null
@@ -1,30 +0,0 @@
-*INCLUDE, INPUT=Solid/all.msh
-*INCLUDE, INPUT=Solid/fix1_beam.nam
-*INCLUDE, INPUT=Solid/interface_beam.nam
-*MATERIAL, Name=EL
-*ELASTIC
- 400000, 0.3
-*DENSITY
- 3000
-*SOLID SECTION, Elset=Eall, Material=EL
-*STEP, NLGEOM, INC=1000000
-*DYNAMIC, DIRECT
-1.E-2, 10.0
-
-** fix on the lower boundary from x to z.
-*BOUNDARY
-Nfix1, 1, 3
-** fix on all nodes for translation in y-dir, rotation about x- and z-axis
-*BOUNDARY
-Nall, 2, 2, 0
-Nall, 4, 4, 0
-Nall, 6, 6, 0
-*CLOAD
- Nsurface, 1, 0.0
- Nsurface, 2, 0.0
- Nsurface, 3, 0.0
-*NODE FILE
- U
-*EL FILE
- S, E
-*END STEP
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/interface_beam.nam b/FSI/flap_perp/OpenFOAM-CalculiX/Solid/interface_beam.nam
deleted file mode 100644
index 2c29a72eb..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/interface_beam.nam
+++ /dev/null
@@ -1,88 +0,0 @@
-** Names based on surface
-*NSET,NSET=Nsurface
-1,
-4,
-5,
-8,
-10,
-12,
-14,
-16,
-18,
-20,
-22,
-24,
-26,
-28,
-30,
-32,
-34,
-36,
-38,
-40,
-42,
-44,
-46,
-48,
-50,
-52,
-54,
-56,
-58,
-60,
-62,
-64,
-66,
-68,
-70,
-72,
-74,
-76,
-78,
-80,
-81,
-82,
-83,
-84,
-85,
-86,
-87,
-88,
-89,
-90,
-91,
-92,
-93,
-94,
-95,
-96,
-97,
-98,
-99,
-100,
-101,
-102,
-103,
-104,
-105,
-106,
-107,
-108,
-109,
-110,
-111,
-112,
-113,
-114,
-115,
-116,
-117,
-118,
-119,
-120,
-121,
-122,
-123,
-124,
-125,
-126,
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/post_flap.fbd b/FSI/flap_perp/OpenFOAM-CalculiX/Solid/post_flap.fbd
deleted file mode 100644
index c5a510124..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/post_flap.fbd
+++ /dev/null
@@ -1,21 +0,0 @@
-ulin perpendicular flap to the flow
-read Solid/flap.frd
-read Solid/flap.inp
-view elem
-view disp
-rot y
-#rot l 180
-ds 1 e 4
-#graph NA time DISP D1
-#q
-#graph NA time DISP D2
-#q
-#quit
-
-anim real
-# movi frames auto
-ds 2 ah 7
-# min 0
-# max 2.5e10
-#sys mv movie.gif figures/displacement.gif
-# quit
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/pre_flap.fbd b/FSI/flap_perp/OpenFOAM-CalculiX/Solid/pre_flap.fbd
deleted file mode 100644
index 629eddf73..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/pre_flap.fbd
+++ /dev/null
@@ -1,50 +0,0 @@
-#!/bin/bash
-#For the beam elements
-valu c 1.
-valu h 0.1
-valu dy 0.3
-valu nd 0.05
-
-pnt p1 -0.05 0 0
-pnt p2 -0.05 dy
-line l1 p1 p2 1
-seta fix1 all
-swep fix1 fix1 tra h 0 0 1
-seta fix1 all
-comp fix1 do
-
-swep all wing tra 0 0 1 1
-seta surface s A002 A003 A004
-comp surface do
-
-
-seta length l L00A L00B L008 L009
-seta width l L002 L003 L006 L007
-
-div length auto nd
-div width auto nd
-elty all he8
-mesh all
-
-
-
-send all abq
-send fix1 abq nam
-send surface abq nam
-
-view elem
-# #rot z
-#rot r 50
-#rot u 50
-
-plot f all
-
-sys mv surface.nam interface_beam.nam
-sys mv fix1.nam fix1_beam.nam
-
-# Add thing here for the boundary condition
-# sys echo
-# quit
-
-# plus la all
-# plus pa all
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/config.yml b/FSI/flap_perp/OpenFOAM-CalculiX/config.yml
deleted file mode 100644
index 8eac35fbc..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/config.yml
+++ /dev/null
@@ -1,10 +0,0 @@
-participants:
-
- Calculix:
- interfaces:
- - nodes-mesh: Solid
- patch: surface
- read-data: [Forces0]
- write-data: [Displacements0]
-
-precice-config-file: ./precice-config.xml
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/plotDisplacement.sh b/FSI/flap_perp/OpenFOAM-CalculiX/plotDisplacement.sh
deleted file mode 100755
index ee1ed3689..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/plotDisplacement.sh
+++ /dev/null
@@ -1,13 +0,0 @@
-#! /bin/bash
-gnuplot -p << EOF
-set grid
-set title 'Displacement of the Flap Tip'
-set xlabel 'Time [s]'
-set ylabel 'X-Displacement [m]'
-# set style line 1 lt 2 lw 6
-# set style line 1 lt 2 lw 6
-# set linestyle 2 lt 2 lc 1 # red-dashed
-set linestyle 1 lt 2 lc 1 # red-dashed
-plot "precice-Calculix-watchpoint-point1.log" using 1:8 title 'Top displacemement' with lines
-EOF
-
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/precice-config.xml b/FSI/flap_perp/OpenFOAM-CalculiX/precice-config.xml
deleted file mode 100644
index 043318288..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/precice-config.xml
+++ /dev/null
@@ -1,81 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/removeObsoleteFolders.sh b/FSI/flap_perp/OpenFOAM-CalculiX/removeObsoleteFolders.sh
deleted file mode 100755
index 80288fe27..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,23 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
-
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/runFluid b/FSI/flap_perp/OpenFOAM-CalculiX/runFluid
deleted file mode 100755
index 02e56e134..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/runFluid
+++ /dev/null
@@ -1,45 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the "runSolid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- solver=$(getApplication)
- procs=$(getNumberOfProcessors)
-cd ..
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $procs $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26
-./removeObsoleteFolders.sh
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/runSolid b/FSI/flap_perp/OpenFOAM-CalculiX/runSolid
deleted file mode 100755
index d4bcfe976..000000000
--- a/FSI/flap_perp/OpenFOAM-CalculiX/runSolid
+++ /dev/null
@@ -1,14 +0,0 @@
-#!/bin/bash
-
-# Solid participant
-
-# Run this script in one terminal and the "runFluid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# The script "Allclean" cleans-up the result and log files.
-
-echo "Running the Solid participant..."
-
-# Run
-ccx_preCICE -i Solid/flap -precice-participant Calculix
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Allclean b/FSI/flap_perp/OpenFOAM-deal.II/Allclean
deleted file mode 100755
index f2b75cbc8..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Allclean
+++ /dev/null
@@ -1,57 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid (OpenFOAM)
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid (deal.II)
-Participant2="Solid"
-cd ./Solid/dealii_output
- # Clean the case
- echo "Cleaning Solid case"
- rm -fv solution-*.vtk
-cd ..
- rm -fv solution-*.vtk
-cd ..
-
-
-rm -fv ${Participant2}.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Allrun b/FSI/flap_perp/OpenFOAM-deal.II/Allrun
deleted file mode 100755
index 0d6483b45..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Allrun
+++ /dev/null
@@ -1,106 +0,0 @@
-#!/bin/bash
-
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the script "runFluid" and start the Solid participant manually
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- echo " Restoring 0/ from 0.orig/..."
- rm -rfv 0
- cp -r 0.orig 0
- cd ..
-
- echo " Preparing the mesh..."
- blockMesh -case ${Participant1} > ${Participant1}_blockMesh.log 2>&1
- checkMesh -case ${Participant1} > ${Participant1}_checkMesh.log 2>&1
-
- # get application information
- cd ${Participant1}
- Solver1=$(getApplication) # solver
- echo " ${Participant1} Solver: ${Solver1}."
- cd ..
-
- # Run and get the process id
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-Solver2="linear_elasticity"
-
- # Run
- echo " Starting the ${Participant2} participant..."
- ./runSolid -linear > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
- if [ $parallel -eq 1 ]; then
- echo "Reconstructing fields..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1 &
- fi
-
- # Workaround for issue #26
- echo "Problems with time directories without results? Run the script removeObsoleteFolders.sh and see issue #26 on GitHub."
- # ./removeObsoleteFolders.sh
-
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/phi b/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/phi
deleted file mode 100644
index 06c61d9c4..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/phi
+++ /dev/null
@@ -1,49 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class surfaceScalarField;
- location "0";
- object phi;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 3 -1 0 0 0 0];
-
-internalField uniform 0;
-boundaryField
-{
- inlet
- {
- type calculated;
- value $internalField;
- }
- outlet
- {
- type calculated;
- value $internalField;
- }
- flap
- {
- type calculated;
- value uniform 0;
- }
- upperWall
- {
- type calculated;
- value uniform 0;
- }
- lowerWall
- {
- type calculated;
- value uniform 0;
- }
- frontAndBack
- {
- type empty;
- value nonuniform 0;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/pointDisplacement b/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/pointDisplacement
deleted file mode 100644
index c107f3b65..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/pointDisplacement
+++ /dev/null
@@ -1,50 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class pointVectorField;
- object pointDisplacement;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 0 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- flap
- {
- type fixedValue;
- value $internalField;
- }
-
- upperWall
- {
- type slip;
- }
-
- lowerWall
- {
- type slip;
- }
-
- frontAndBack
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/Fluid.foam b/FSI/flap_perp/OpenFOAM-deal.II/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict b/FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict
deleted file mode 100644
index d323bc059..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict
+++ /dev/null
@@ -1,22 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object dynamicMeshDict;
-}
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dynamicFvMesh dynamicMotionSolverFvMesh;
-
-motionSolverLibs ("libfvMotionSolvers.so");
-
-solver displacementLaplacian;
-
-displacementLaplacianCoeffs {
-
- diffusivity quadratic inverseDistance (flap);
-
-}
\ No newline at end of file
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/blockMeshDict b/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/blockMeshDict
deleted file mode 100644
index 54c55c41e..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/blockMeshDict
+++ /dev/null
@@ -1,153 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-scale 1.;
-
-x0 -3.;
-x1 -0.05;
-x2 0.05;
-x3 3.;
-
-z0 0.;
-z1 1.;
-z2 4.;
-
-//w1 0.3;
-w 0;
-vertices
-(
- ($x0 $z0 $w ) // 0
- ($x1 $z0 $w ) // 1
- ($x2 $z0 $w ) // 2
- ($x3 $z0 $w ) // 3
- ($x0 $z1 $w ) // 4
- ($x1 $z1 $w ) // 5
- ($x2 $z1 $w ) // 6
- ($x3 $z1 $w ) // 7
- ($x0 $z2 $w ) // 8
- ($x1 $z2 $w ) // 9
- ($x2 $z2 $w ) // 10
- ($x3 $z2 $w ) // 11
-
- ($x0 $z0 0.3 ) // 12
- ($x1 $z0 0.3) // 13
- ($x2 $z0 0.3) // 14
- ($x3 $z0 0.3) // 15
- ($x0 $z1 0.3) // 16
- ($x1 $z1 0.3) // 17
- ($x2 $z1 0.3) // 18
- ($x3 $z1 0.3) // 19
- ($x0 $z2 0.3) // 20
- ($x1 $z2 0.3) // 21
- ($x2 $z2 0.3) // 22
- ($x3 $z2 0.3) // 23
-);
-
-// Grading
-h1 30;
-h2 3;
-v1 15;
-v2 30;
-
-blocks
-(
- hex ( 0 1 5 4 12 13 17 16 )
- ($h1 $v1 1 )
- simpleGrading (0.5 1 1)
-
- hex ( 2 3 7 6 14 15 19 18 )
- ($h1 $v1 1)
- simpleGrading (2 1 1)
-
- hex ( 4 5 9 8 16 17 21 20 )
- ($h1 $v2 1)
- simpleGrading (0.5 2 1)
-
- hex ( 5 6 10 9 17 18 22 21 )
- ($h2 $v2 1)
- simpleGrading (1 2 1)
-
- hex ( 6 7 11 10 18 19 23 22 )
- ($h1 $v2 1 )
- simpleGrading (2 2 1)
-);
-
-edges
-(
-);
-
-boundary
-(
- inlet
- {
- type patch;
- faces
- (
- ( 0 4 16 12 )
- ( 4 8 20 16 )
- );
- }
- outlet
- {
- type patch;
- faces
- (
- ( 3 7 19 15 )
- ( 7 11 23 19 )
- );
- }
- flap
- {
- type wall;
- faces
- (
- ( 1 5 17 13 )
- ( 5 6 18 17 )
- ( 6 2 14 18 )
- );
- }
- upperWall
- {
- type wall;
- faces
- (
- ( 8 9 21 20 )
- ( 9 10 22 21 )
- ( 10 11 23 22 )
- );
- }
- lowerWall
- {
- type wall;
- faces
- (
- ( 0 1 13 12 )
- ( 2 3 15 14 )
- );
- }
- frontAndBack
- {
- type empty;
- faces
- (
- ( 0 1 5 4 )
- ( 2 3 7 6 )
- ( 4 5 9 8 )
- ( 5 6 10 9 )
- ( 6 7 11 10 )
- ( 12 13 17 16 )
- ( 14 15 19 18 )
- ( 16 17 21 20 )
- ( 17 18 22 21 )
- ( 18 19 23 22 )
- );
- }
-);
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/displacementProbe b/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/displacementProbe
deleted file mode 100644
index 2bad5f4af..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/displacementProbe
+++ /dev/null
@@ -1,18 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-Description
- Writes out values of fields from cells nearest to specified locations.
-
-\*---------------------------------------------------------------------------*/
-
-#includeEtc "caseDicts/postProcessing/probes/probes.cfg"
-type probes;
-probeLocations
-(
- (0 0.15 1.0)
-);
-fields
-(
- cellDisplacement
-);
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/README.md b/FSI/flap_perp/OpenFOAM-deal.II/README.md
deleted file mode 100644
index f86d5a7ba..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/README.md
+++ /dev/null
@@ -1,18 +0,0 @@
-# Tutorial for an FSI simulation of an elastic flap perpendicular to a channel flow
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM). Have also a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-You may run the coupled simulation in serial using the script `Allrun` or (OpenFOAM) in parallel with `Allrun -parallel`. The output of each step will be redirected to log files. You can cleanup the simulation using `Allclean`.
-
-If you prefer to run the two simulations in two different terminals and watch their output on the screen, use the (simpler) scripts `runFluid` (or `runFluid -parallel`).
-
-Before starting the deal.II program, it needs to be compiled and copied in this case directory. Information about building is collected in the [deal.II wiki](https://github.com/precice/dealii-adapter/wiki/Building). You can use the following command to run e.g. the linear deal.II solver afterwards:
-```
-./runSolid -linear
-```
-
-There is an [open issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. Please run the script `removeObsoleteSolvers.sh` to delete the additional files.
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Solid/dealii_output/initial_grid.vtk b/FSI/flap_perp/OpenFOAM-deal.II/Solid/dealii_output/initial_grid.vtk
deleted file mode 100644
index 2ddf22038..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Solid/dealii_output/initial_grid.vtk
+++ /dev/null
@@ -1,2590 +0,0 @@
-# vtk DataFile Version 3.0
-#This file was generated by the deal.II library on 2019/6/13 at 19:20:25
-ASCII
-DATASET UNSTRUCTURED_GRID
-
-POINTS 1200 double
--0.05 0 0
--0.03 0 0
--0.05 0.0333333 0
--0.03 0.0333333 0
--0.05 0 0.3
--0.03 0 0.3
--0.05 0.0333333 0.3
--0.03 0.0333333 0.3
--0.03 0 0
--0.01 0 0
--0.03 0.0333333 0
--0.01 0.0333333 0
--0.03 0 0.3
--0.01 0 0.3
--0.03 0.0333333 0.3
--0.01 0.0333333 0.3
--0.01 0 0
-0.01 0 0
--0.01 0.0333333 0
-0.01 0.0333333 0
--0.01 0 0.3
-0.01 0 0.3
--0.01 0.0333333 0.3
-0.01 0.0333333 0.3
-0.01 0 0
-0.03 0 0
-0.01 0.0333333 0
-0.03 0.0333333 0
-0.01 0 0.3
-0.03 0 0.3
-0.01 0.0333333 0.3
-0.03 0.0333333 0.3
-0.03 0 0
-0.05 0 0
-0.03 0.0333333 0
-0.05 0.0333333 0
-0.03 0 0.3
-0.05 0 0.3
-0.03 0.0333333 0.3
-0.05 0.0333333 0.3
--0.05 0.0333333 0
--0.03 0.0333333 0
--0.05 0.0666667 0
--0.03 0.0666667 0
--0.05 0.0333333 0.3
--0.03 0.0333333 0.3
--0.05 0.0666667 0.3
--0.03 0.0666667 0.3
--0.03 0.0333333 0
--0.01 0.0333333 0
--0.03 0.0666667 0
--0.01 0.0666667 0
--0.03 0.0333333 0.3
--0.01 0.0333333 0.3
--0.03 0.0666667 0.3
--0.01 0.0666667 0.3
--0.01 0.0333333 0
-0.01 0.0333333 0
--0.01 0.0666667 0
-0.01 0.0666667 0
--0.01 0.0333333 0.3
-0.01 0.0333333 0.3
--0.01 0.0666667 0.3
-0.01 0.0666667 0.3
-0.01 0.0333333 0
-0.03 0.0333333 0
-0.01 0.0666667 0
-0.03 0.0666667 0
-0.01 0.0333333 0.3
-0.03 0.0333333 0.3
-0.01 0.0666667 0.3
-0.03 0.0666667 0.3
-0.03 0.0333333 0
-0.05 0.0333333 0
-0.03 0.0666667 0
-0.05 0.0666667 0
-0.03 0.0333333 0.3
-0.05 0.0333333 0.3
-0.03 0.0666667 0.3
-0.05 0.0666667 0.3
--0.05 0.0666667 0
--0.03 0.0666667 0
--0.05 0.1 0
--0.03 0.1 0
--0.05 0.0666667 0.3
--0.03 0.0666667 0.3
--0.05 0.1 0.3
--0.03 0.1 0.3
--0.03 0.0666667 0
--0.01 0.0666667 0
--0.03 0.1 0
--0.01 0.1 0
--0.03 0.0666667 0.3
--0.01 0.0666667 0.3
--0.03 0.1 0.3
--0.01 0.1 0.3
--0.01 0.0666667 0
-0.01 0.0666667 0
--0.01 0.1 0
-0.01 0.1 0
--0.01 0.0666667 0.3
-0.01 0.0666667 0.3
--0.01 0.1 0.3
-0.01 0.1 0.3
-0.01 0.0666667 0
-0.03 0.0666667 0
-0.01 0.1 0
-0.03 0.1 0
-0.01 0.0666667 0.3
-0.03 0.0666667 0.3
-0.01 0.1 0.3
-0.03 0.1 0.3
-0.03 0.0666667 0
-0.05 0.0666667 0
-0.03 0.1 0
-0.05 0.1 0
-0.03 0.0666667 0.3
-0.05 0.0666667 0.3
-0.03 0.1 0.3
-0.05 0.1 0.3
--0.05 0.1 0
--0.03 0.1 0
--0.05 0.133333 0
--0.03 0.133333 0
--0.05 0.1 0.3
--0.03 0.1 0.3
--0.05 0.133333 0.3
--0.03 0.133333 0.3
--0.03 0.1 0
--0.01 0.1 0
--0.03 0.133333 0
--0.01 0.133333 0
--0.03 0.1 0.3
--0.01 0.1 0.3
--0.03 0.133333 0.3
--0.01 0.133333 0.3
--0.01 0.1 0
-0.01 0.1 0
--0.01 0.133333 0
-0.01 0.133333 0
--0.01 0.1 0.3
-0.01 0.1 0.3
--0.01 0.133333 0.3
-0.01 0.133333 0.3
-0.01 0.1 0
-0.03 0.1 0
-0.01 0.133333 0
-0.03 0.133333 0
-0.01 0.1 0.3
-0.03 0.1 0.3
-0.01 0.133333 0.3
-0.03 0.133333 0.3
-0.03 0.1 0
-0.05 0.1 0
-0.03 0.133333 0
-0.05 0.133333 0
-0.03 0.1 0.3
-0.05 0.1 0.3
-0.03 0.133333 0.3
-0.05 0.133333 0.3
--0.05 0.133333 0
--0.03 0.133333 0
--0.05 0.166667 0
--0.03 0.166667 0
--0.05 0.133333 0.3
--0.03 0.133333 0.3
--0.05 0.166667 0.3
--0.03 0.166667 0.3
--0.03 0.133333 0
--0.01 0.133333 0
--0.03 0.166667 0
--0.01 0.166667 0
--0.03 0.133333 0.3
--0.01 0.133333 0.3
--0.03 0.166667 0.3
--0.01 0.166667 0.3
--0.01 0.133333 0
-0.01 0.133333 0
--0.01 0.166667 0
-0.01 0.166667 0
--0.01 0.133333 0.3
-0.01 0.133333 0.3
--0.01 0.166667 0.3
-0.01 0.166667 0.3
-0.01 0.133333 0
-0.03 0.133333 0
-0.01 0.166667 0
-0.03 0.166667 0
-0.01 0.133333 0.3
-0.03 0.133333 0.3
-0.01 0.166667 0.3
-0.03 0.166667 0.3
-0.03 0.133333 0
-0.05 0.133333 0
-0.03 0.166667 0
-0.05 0.166667 0
-0.03 0.133333 0.3
-0.05 0.133333 0.3
-0.03 0.166667 0.3
-0.05 0.166667 0.3
--0.05 0.166667 0
--0.03 0.166667 0
--0.05 0.2 0
--0.03 0.2 0
--0.05 0.166667 0.3
--0.03 0.166667 0.3
--0.05 0.2 0.3
--0.03 0.2 0.3
--0.03 0.166667 0
--0.01 0.166667 0
--0.03 0.2 0
--0.01 0.2 0
--0.03 0.166667 0.3
--0.01 0.166667 0.3
--0.03 0.2 0.3
--0.01 0.2 0.3
--0.01 0.166667 0
-0.01 0.166667 0
--0.01 0.2 0
-0.01 0.2 0
--0.01 0.166667 0.3
-0.01 0.166667 0.3
--0.01 0.2 0.3
-0.01 0.2 0.3
-0.01 0.166667 0
-0.03 0.166667 0
-0.01 0.2 0
-0.03 0.2 0
-0.01 0.166667 0.3
-0.03 0.166667 0.3
-0.01 0.2 0.3
-0.03 0.2 0.3
-0.03 0.166667 0
-0.05 0.166667 0
-0.03 0.2 0
-0.05 0.2 0
-0.03 0.166667 0.3
-0.05 0.166667 0.3
-0.03 0.2 0.3
-0.05 0.2 0.3
--0.05 0.2 0
--0.03 0.2 0
--0.05 0.233333 0
--0.03 0.233333 0
--0.05 0.2 0.3
--0.03 0.2 0.3
--0.05 0.233333 0.3
--0.03 0.233333 0.3
--0.03 0.2 0
--0.01 0.2 0
--0.03 0.233333 0
--0.01 0.233333 0
--0.03 0.2 0.3
--0.01 0.2 0.3
--0.03 0.233333 0.3
--0.01 0.233333 0.3
--0.01 0.2 0
-0.01 0.2 0
--0.01 0.233333 0
-0.01 0.233333 0
--0.01 0.2 0.3
-0.01 0.2 0.3
--0.01 0.233333 0.3
-0.01 0.233333 0.3
-0.01 0.2 0
-0.03 0.2 0
-0.01 0.233333 0
-0.03 0.233333 0
-0.01 0.2 0.3
-0.03 0.2 0.3
-0.01 0.233333 0.3
-0.03 0.233333 0.3
-0.03 0.2 0
-0.05 0.2 0
-0.03 0.233333 0
-0.05 0.233333 0
-0.03 0.2 0.3
-0.05 0.2 0.3
-0.03 0.233333 0.3
-0.05 0.233333 0.3
--0.05 0.233333 0
--0.03 0.233333 0
--0.05 0.266667 0
--0.03 0.266667 0
--0.05 0.233333 0.3
--0.03 0.233333 0.3
--0.05 0.266667 0.3
--0.03 0.266667 0.3
--0.03 0.233333 0
--0.01 0.233333 0
--0.03 0.266667 0
--0.01 0.266667 0
--0.03 0.233333 0.3
--0.01 0.233333 0.3
--0.03 0.266667 0.3
--0.01 0.266667 0.3
--0.01 0.233333 0
-0.01 0.233333 0
--0.01 0.266667 0
-0.01 0.266667 0
--0.01 0.233333 0.3
-0.01 0.233333 0.3
--0.01 0.266667 0.3
-0.01 0.266667 0.3
-0.01 0.233333 0
-0.03 0.233333 0
-0.01 0.266667 0
-0.03 0.266667 0
-0.01 0.233333 0.3
-0.03 0.233333 0.3
-0.01 0.266667 0.3
-0.03 0.266667 0.3
-0.03 0.233333 0
-0.05 0.233333 0
-0.03 0.266667 0
-0.05 0.266667 0
-0.03 0.233333 0.3
-0.05 0.233333 0.3
-0.03 0.266667 0.3
-0.05 0.266667 0.3
--0.05 0.266667 0
--0.03 0.266667 0
--0.05 0.3 0
--0.03 0.3 0
--0.05 0.266667 0.3
--0.03 0.266667 0.3
--0.05 0.3 0.3
--0.03 0.3 0.3
--0.03 0.266667 0
--0.01 0.266667 0
--0.03 0.3 0
--0.01 0.3 0
--0.03 0.266667 0.3
--0.01 0.266667 0.3
--0.03 0.3 0.3
--0.01 0.3 0.3
--0.01 0.266667 0
-0.01 0.266667 0
--0.01 0.3 0
-0.01 0.3 0
--0.01 0.266667 0.3
-0.01 0.266667 0.3
--0.01 0.3 0.3
-0.01 0.3 0.3
-0.01 0.266667 0
-0.03 0.266667 0
-0.01 0.3 0
-0.03 0.3 0
-0.01 0.266667 0.3
-0.03 0.266667 0.3
-0.01 0.3 0.3
-0.03 0.3 0.3
-0.03 0.266667 0
-0.05 0.266667 0
-0.03 0.3 0
-0.05 0.3 0
-0.03 0.266667 0.3
-0.05 0.266667 0.3
-0.03 0.3 0.3
-0.05 0.3 0.3
--0.05 0.3 0
--0.03 0.3 0
--0.05 0.333333 0
--0.03 0.333333 0
--0.05 0.3 0.3
--0.03 0.3 0.3
--0.05 0.333333 0.3
--0.03 0.333333 0.3
--0.03 0.3 0
--0.01 0.3 0
--0.03 0.333333 0
--0.01 0.333333 0
--0.03 0.3 0.3
--0.01 0.3 0.3
--0.03 0.333333 0.3
--0.01 0.333333 0.3
--0.01 0.3 0
-0.01 0.3 0
--0.01 0.333333 0
-0.01 0.333333 0
--0.01 0.3 0.3
-0.01 0.3 0.3
--0.01 0.333333 0.3
-0.01 0.333333 0.3
-0.01 0.3 0
-0.03 0.3 0
-0.01 0.333333 0
-0.03 0.333333 0
-0.01 0.3 0.3
-0.03 0.3 0.3
-0.01 0.333333 0.3
-0.03 0.333333 0.3
-0.03 0.3 0
-0.05 0.3 0
-0.03 0.333333 0
-0.05 0.333333 0
-0.03 0.3 0.3
-0.05 0.3 0.3
-0.03 0.333333 0.3
-0.05 0.333333 0.3
--0.05 0.333333 0
--0.03 0.333333 0
--0.05 0.366667 0
--0.03 0.366667 0
--0.05 0.333333 0.3
--0.03 0.333333 0.3
--0.05 0.366667 0.3
--0.03 0.366667 0.3
--0.03 0.333333 0
--0.01 0.333333 0
--0.03 0.366667 0
--0.01 0.366667 0
--0.03 0.333333 0.3
--0.01 0.333333 0.3
--0.03 0.366667 0.3
--0.01 0.366667 0.3
--0.01 0.333333 0
-0.01 0.333333 0
--0.01 0.366667 0
-0.01 0.366667 0
--0.01 0.333333 0.3
-0.01 0.333333 0.3
--0.01 0.366667 0.3
-0.01 0.366667 0.3
-0.01 0.333333 0
-0.03 0.333333 0
-0.01 0.366667 0
-0.03 0.366667 0
-0.01 0.333333 0.3
-0.03 0.333333 0.3
-0.01 0.366667 0.3
-0.03 0.366667 0.3
-0.03 0.333333 0
-0.05 0.333333 0
-0.03 0.366667 0
-0.05 0.366667 0
-0.03 0.333333 0.3
-0.05 0.333333 0.3
-0.03 0.366667 0.3
-0.05 0.366667 0.3
--0.05 0.366667 0
--0.03 0.366667 0
--0.05 0.4 0
--0.03 0.4 0
--0.05 0.366667 0.3
--0.03 0.366667 0.3
--0.05 0.4 0.3
--0.03 0.4 0.3
--0.03 0.366667 0
--0.01 0.366667 0
--0.03 0.4 0
--0.01 0.4 0
--0.03 0.366667 0.3
--0.01 0.366667 0.3
--0.03 0.4 0.3
--0.01 0.4 0.3
--0.01 0.366667 0
-0.01 0.366667 0
--0.01 0.4 0
-0.01 0.4 0
--0.01 0.366667 0.3
-0.01 0.366667 0.3
--0.01 0.4 0.3
-0.01 0.4 0.3
-0.01 0.366667 0
-0.03 0.366667 0
-0.01 0.4 0
-0.03 0.4 0
-0.01 0.366667 0.3
-0.03 0.366667 0.3
-0.01 0.4 0.3
-0.03 0.4 0.3
-0.03 0.366667 0
-0.05 0.366667 0
-0.03 0.4 0
-0.05 0.4 0
-0.03 0.366667 0.3
-0.05 0.366667 0.3
-0.03 0.4 0.3
-0.05 0.4 0.3
--0.05 0.4 0
--0.03 0.4 0
--0.05 0.433333 0
--0.03 0.433333 0
--0.05 0.4 0.3
--0.03 0.4 0.3
--0.05 0.433333 0.3
--0.03 0.433333 0.3
--0.03 0.4 0
--0.01 0.4 0
--0.03 0.433333 0
--0.01 0.433333 0
--0.03 0.4 0.3
--0.01 0.4 0.3
--0.03 0.433333 0.3
--0.01 0.433333 0.3
--0.01 0.4 0
-0.01 0.4 0
--0.01 0.433333 0
-0.01 0.433333 0
--0.01 0.4 0.3
-0.01 0.4 0.3
--0.01 0.433333 0.3
-0.01 0.433333 0.3
-0.01 0.4 0
-0.03 0.4 0
-0.01 0.433333 0
-0.03 0.433333 0
-0.01 0.4 0.3
-0.03 0.4 0.3
-0.01 0.433333 0.3
-0.03 0.433333 0.3
-0.03 0.4 0
-0.05 0.4 0
-0.03 0.433333 0
-0.05 0.433333 0
-0.03 0.4 0.3
-0.05 0.4 0.3
-0.03 0.433333 0.3
-0.05 0.433333 0.3
--0.05 0.433333 0
--0.03 0.433333 0
--0.05 0.466667 0
--0.03 0.466667 0
--0.05 0.433333 0.3
--0.03 0.433333 0.3
--0.05 0.466667 0.3
--0.03 0.466667 0.3
--0.03 0.433333 0
--0.01 0.433333 0
--0.03 0.466667 0
--0.01 0.466667 0
--0.03 0.433333 0.3
--0.01 0.433333 0.3
--0.03 0.466667 0.3
--0.01 0.466667 0.3
--0.01 0.433333 0
-0.01 0.433333 0
--0.01 0.466667 0
-0.01 0.466667 0
--0.01 0.433333 0.3
-0.01 0.433333 0.3
--0.01 0.466667 0.3
-0.01 0.466667 0.3
-0.01 0.433333 0
-0.03 0.433333 0
-0.01 0.466667 0
-0.03 0.466667 0
-0.01 0.433333 0.3
-0.03 0.433333 0.3
-0.01 0.466667 0.3
-0.03 0.466667 0.3
-0.03 0.433333 0
-0.05 0.433333 0
-0.03 0.466667 0
-0.05 0.466667 0
-0.03 0.433333 0.3
-0.05 0.433333 0.3
-0.03 0.466667 0.3
-0.05 0.466667 0.3
--0.05 0.466667 0
--0.03 0.466667 0
--0.05 0.5 0
--0.03 0.5 0
--0.05 0.466667 0.3
--0.03 0.466667 0.3
--0.05 0.5 0.3
--0.03 0.5 0.3
--0.03 0.466667 0
--0.01 0.466667 0
--0.03 0.5 0
--0.01 0.5 0
--0.03 0.466667 0.3
--0.01 0.466667 0.3
--0.03 0.5 0.3
--0.01 0.5 0.3
--0.01 0.466667 0
-0.01 0.466667 0
--0.01 0.5 0
-0.01 0.5 0
--0.01 0.466667 0.3
-0.01 0.466667 0.3
--0.01 0.5 0.3
-0.01 0.5 0.3
-0.01 0.466667 0
-0.03 0.466667 0
-0.01 0.5 0
-0.03 0.5 0
-0.01 0.466667 0.3
-0.03 0.466667 0.3
-0.01 0.5 0.3
-0.03 0.5 0.3
-0.03 0.466667 0
-0.05 0.466667 0
-0.03 0.5 0
-0.05 0.5 0
-0.03 0.466667 0.3
-0.05 0.466667 0.3
-0.03 0.5 0.3
-0.05 0.5 0.3
--0.05 0.5 0
--0.03 0.5 0
--0.05 0.533333 0
--0.03 0.533333 0
--0.05 0.5 0.3
--0.03 0.5 0.3
--0.05 0.533333 0.3
--0.03 0.533333 0.3
--0.03 0.5 0
--0.01 0.5 0
--0.03 0.533333 0
--0.01 0.533333 0
--0.03 0.5 0.3
--0.01 0.5 0.3
--0.03 0.533333 0.3
--0.01 0.533333 0.3
--0.01 0.5 0
-0.01 0.5 0
--0.01 0.533333 0
-0.01 0.533333 0
--0.01 0.5 0.3
-0.01 0.5 0.3
--0.01 0.533333 0.3
-0.01 0.533333 0.3
-0.01 0.5 0
-0.03 0.5 0
-0.01 0.533333 0
-0.03 0.533333 0
-0.01 0.5 0.3
-0.03 0.5 0.3
-0.01 0.533333 0.3
-0.03 0.533333 0.3
-0.03 0.5 0
-0.05 0.5 0
-0.03 0.533333 0
-0.05 0.533333 0
-0.03 0.5 0.3
-0.05 0.5 0.3
-0.03 0.533333 0.3
-0.05 0.533333 0.3
--0.05 0.533333 0
--0.03 0.533333 0
--0.05 0.566667 0
--0.03 0.566667 0
--0.05 0.533333 0.3
--0.03 0.533333 0.3
--0.05 0.566667 0.3
--0.03 0.566667 0.3
--0.03 0.533333 0
--0.01 0.533333 0
--0.03 0.566667 0
--0.01 0.566667 0
--0.03 0.533333 0.3
--0.01 0.533333 0.3
--0.03 0.566667 0.3
--0.01 0.566667 0.3
--0.01 0.533333 0
-0.01 0.533333 0
--0.01 0.566667 0
-0.01 0.566667 0
--0.01 0.533333 0.3
-0.01 0.533333 0.3
--0.01 0.566667 0.3
-0.01 0.566667 0.3
-0.01 0.533333 0
-0.03 0.533333 0
-0.01 0.566667 0
-0.03 0.566667 0
-0.01 0.533333 0.3
-0.03 0.533333 0.3
-0.01 0.566667 0.3
-0.03 0.566667 0.3
-0.03 0.533333 0
-0.05 0.533333 0
-0.03 0.566667 0
-0.05 0.566667 0
-0.03 0.533333 0.3
-0.05 0.533333 0.3
-0.03 0.566667 0.3
-0.05 0.566667 0.3
--0.05 0.566667 0
--0.03 0.566667 0
--0.05 0.6 0
--0.03 0.6 0
--0.05 0.566667 0.3
--0.03 0.566667 0.3
--0.05 0.6 0.3
--0.03 0.6 0.3
--0.03 0.566667 0
--0.01 0.566667 0
--0.03 0.6 0
--0.01 0.6 0
--0.03 0.566667 0.3
--0.01 0.566667 0.3
--0.03 0.6 0.3
--0.01 0.6 0.3
--0.01 0.566667 0
-0.01 0.566667 0
--0.01 0.6 0
-0.01 0.6 0
--0.01 0.566667 0.3
-0.01 0.566667 0.3
--0.01 0.6 0.3
-0.01 0.6 0.3
-0.01 0.566667 0
-0.03 0.566667 0
-0.01 0.6 0
-0.03 0.6 0
-0.01 0.566667 0.3
-0.03 0.566667 0.3
-0.01 0.6 0.3
-0.03 0.6 0.3
-0.03 0.566667 0
-0.05 0.566667 0
-0.03 0.6 0
-0.05 0.6 0
-0.03 0.566667 0.3
-0.05 0.566667 0.3
-0.03 0.6 0.3
-0.05 0.6 0.3
--0.05 0.6 0
--0.03 0.6 0
--0.05 0.633333 0
--0.03 0.633333 0
--0.05 0.6 0.3
--0.03 0.6 0.3
--0.05 0.633333 0.3
--0.03 0.633333 0.3
--0.03 0.6 0
--0.01 0.6 0
--0.03 0.633333 0
--0.01 0.633333 0
--0.03 0.6 0.3
--0.01 0.6 0.3
--0.03 0.633333 0.3
--0.01 0.633333 0.3
--0.01 0.6 0
-0.01 0.6 0
--0.01 0.633333 0
-0.01 0.633333 0
--0.01 0.6 0.3
-0.01 0.6 0.3
--0.01 0.633333 0.3
-0.01 0.633333 0.3
-0.01 0.6 0
-0.03 0.6 0
-0.01 0.633333 0
-0.03 0.633333 0
-0.01 0.6 0.3
-0.03 0.6 0.3
-0.01 0.633333 0.3
-0.03 0.633333 0.3
-0.03 0.6 0
-0.05 0.6 0
-0.03 0.633333 0
-0.05 0.633333 0
-0.03 0.6 0.3
-0.05 0.6 0.3
-0.03 0.633333 0.3
-0.05 0.633333 0.3
--0.05 0.633333 0
--0.03 0.633333 0
--0.05 0.666667 0
--0.03 0.666667 0
--0.05 0.633333 0.3
--0.03 0.633333 0.3
--0.05 0.666667 0.3
--0.03 0.666667 0.3
--0.03 0.633333 0
--0.01 0.633333 0
--0.03 0.666667 0
--0.01 0.666667 0
--0.03 0.633333 0.3
--0.01 0.633333 0.3
--0.03 0.666667 0.3
--0.01 0.666667 0.3
--0.01 0.633333 0
-0.01 0.633333 0
--0.01 0.666667 0
-0.01 0.666667 0
--0.01 0.633333 0.3
-0.01 0.633333 0.3
--0.01 0.666667 0.3
-0.01 0.666667 0.3
-0.01 0.633333 0
-0.03 0.633333 0
-0.01 0.666667 0
-0.03 0.666667 0
-0.01 0.633333 0.3
-0.03 0.633333 0.3
-0.01 0.666667 0.3
-0.03 0.666667 0.3
-0.03 0.633333 0
-0.05 0.633333 0
-0.03 0.666667 0
-0.05 0.666667 0
-0.03 0.633333 0.3
-0.05 0.633333 0.3
-0.03 0.666667 0.3
-0.05 0.666667 0.3
--0.05 0.666667 0
--0.03 0.666667 0
--0.05 0.7 0
--0.03 0.7 0
--0.05 0.666667 0.3
--0.03 0.666667 0.3
--0.05 0.7 0.3
--0.03 0.7 0.3
--0.03 0.666667 0
--0.01 0.666667 0
--0.03 0.7 0
--0.01 0.7 0
--0.03 0.666667 0.3
--0.01 0.666667 0.3
--0.03 0.7 0.3
--0.01 0.7 0.3
--0.01 0.666667 0
-0.01 0.666667 0
--0.01 0.7 0
-0.01 0.7 0
--0.01 0.666667 0.3
-0.01 0.666667 0.3
--0.01 0.7 0.3
-0.01 0.7 0.3
-0.01 0.666667 0
-0.03 0.666667 0
-0.01 0.7 0
-0.03 0.7 0
-0.01 0.666667 0.3
-0.03 0.666667 0.3
-0.01 0.7 0.3
-0.03 0.7 0.3
-0.03 0.666667 0
-0.05 0.666667 0
-0.03 0.7 0
-0.05 0.7 0
-0.03 0.666667 0.3
-0.05 0.666667 0.3
-0.03 0.7 0.3
-0.05 0.7 0.3
--0.05 0.7 0
--0.03 0.7 0
--0.05 0.733333 0
--0.03 0.733333 0
--0.05 0.7 0.3
--0.03 0.7 0.3
--0.05 0.733333 0.3
--0.03 0.733333 0.3
--0.03 0.7 0
--0.01 0.7 0
--0.03 0.733333 0
--0.01 0.733333 0
--0.03 0.7 0.3
--0.01 0.7 0.3
--0.03 0.733333 0.3
--0.01 0.733333 0.3
--0.01 0.7 0
-0.01 0.7 0
--0.01 0.733333 0
-0.01 0.733333 0
--0.01 0.7 0.3
-0.01 0.7 0.3
--0.01 0.733333 0.3
-0.01 0.733333 0.3
-0.01 0.7 0
-0.03 0.7 0
-0.01 0.733333 0
-0.03 0.733333 0
-0.01 0.7 0.3
-0.03 0.7 0.3
-0.01 0.733333 0.3
-0.03 0.733333 0.3
-0.03 0.7 0
-0.05 0.7 0
-0.03 0.733333 0
-0.05 0.733333 0
-0.03 0.7 0.3
-0.05 0.7 0.3
-0.03 0.733333 0.3
-0.05 0.733333 0.3
--0.05 0.733333 0
--0.03 0.733333 0
--0.05 0.766667 0
--0.03 0.766667 0
--0.05 0.733333 0.3
--0.03 0.733333 0.3
--0.05 0.766667 0.3
--0.03 0.766667 0.3
--0.03 0.733333 0
--0.01 0.733333 0
--0.03 0.766667 0
--0.01 0.766667 0
--0.03 0.733333 0.3
--0.01 0.733333 0.3
--0.03 0.766667 0.3
--0.01 0.766667 0.3
--0.01 0.733333 0
-0.01 0.733333 0
--0.01 0.766667 0
-0.01 0.766667 0
--0.01 0.733333 0.3
-0.01 0.733333 0.3
--0.01 0.766667 0.3
-0.01 0.766667 0.3
-0.01 0.733333 0
-0.03 0.733333 0
-0.01 0.766667 0
-0.03 0.766667 0
-0.01 0.733333 0.3
-0.03 0.733333 0.3
-0.01 0.766667 0.3
-0.03 0.766667 0.3
-0.03 0.733333 0
-0.05 0.733333 0
-0.03 0.766667 0
-0.05 0.766667 0
-0.03 0.733333 0.3
-0.05 0.733333 0.3
-0.03 0.766667 0.3
-0.05 0.766667 0.3
--0.05 0.766667 0
--0.03 0.766667 0
--0.05 0.8 0
--0.03 0.8 0
--0.05 0.766667 0.3
--0.03 0.766667 0.3
--0.05 0.8 0.3
--0.03 0.8 0.3
--0.03 0.766667 0
--0.01 0.766667 0
--0.03 0.8 0
--0.01 0.8 0
--0.03 0.766667 0.3
--0.01 0.766667 0.3
--0.03 0.8 0.3
--0.01 0.8 0.3
--0.01 0.766667 0
-0.01 0.766667 0
--0.01 0.8 0
-0.01 0.8 0
--0.01 0.766667 0.3
-0.01 0.766667 0.3
--0.01 0.8 0.3
-0.01 0.8 0.3
-0.01 0.766667 0
-0.03 0.766667 0
-0.01 0.8 0
-0.03 0.8 0
-0.01 0.766667 0.3
-0.03 0.766667 0.3
-0.01 0.8 0.3
-0.03 0.8 0.3
-0.03 0.766667 0
-0.05 0.766667 0
-0.03 0.8 0
-0.05 0.8 0
-0.03 0.766667 0.3
-0.05 0.766667 0.3
-0.03 0.8 0.3
-0.05 0.8 0.3
--0.05 0.8 0
--0.03 0.8 0
--0.05 0.833333 0
--0.03 0.833333 0
--0.05 0.8 0.3
--0.03 0.8 0.3
--0.05 0.833333 0.3
--0.03 0.833333 0.3
--0.03 0.8 0
--0.01 0.8 0
--0.03 0.833333 0
--0.01 0.833333 0
--0.03 0.8 0.3
--0.01 0.8 0.3
--0.03 0.833333 0.3
--0.01 0.833333 0.3
--0.01 0.8 0
-0.01 0.8 0
--0.01 0.833333 0
-0.01 0.833333 0
--0.01 0.8 0.3
-0.01 0.8 0.3
--0.01 0.833333 0.3
-0.01 0.833333 0.3
-0.01 0.8 0
-0.03 0.8 0
-0.01 0.833333 0
-0.03 0.833333 0
-0.01 0.8 0.3
-0.03 0.8 0.3
-0.01 0.833333 0.3
-0.03 0.833333 0.3
-0.03 0.8 0
-0.05 0.8 0
-0.03 0.833333 0
-0.05 0.833333 0
-0.03 0.8 0.3
-0.05 0.8 0.3
-0.03 0.833333 0.3
-0.05 0.833333 0.3
--0.05 0.833333 0
--0.03 0.833333 0
--0.05 0.866667 0
--0.03 0.866667 0
--0.05 0.833333 0.3
--0.03 0.833333 0.3
--0.05 0.866667 0.3
--0.03 0.866667 0.3
--0.03 0.833333 0
--0.01 0.833333 0
--0.03 0.866667 0
--0.01 0.866667 0
--0.03 0.833333 0.3
--0.01 0.833333 0.3
--0.03 0.866667 0.3
--0.01 0.866667 0.3
--0.01 0.833333 0
-0.01 0.833333 0
--0.01 0.866667 0
-0.01 0.866667 0
--0.01 0.833333 0.3
-0.01 0.833333 0.3
--0.01 0.866667 0.3
-0.01 0.866667 0.3
-0.01 0.833333 0
-0.03 0.833333 0
-0.01 0.866667 0
-0.03 0.866667 0
-0.01 0.833333 0.3
-0.03 0.833333 0.3
-0.01 0.866667 0.3
-0.03 0.866667 0.3
-0.03 0.833333 0
-0.05 0.833333 0
-0.03 0.866667 0
-0.05 0.866667 0
-0.03 0.833333 0.3
-0.05 0.833333 0.3
-0.03 0.866667 0.3
-0.05 0.866667 0.3
--0.05 0.866667 0
--0.03 0.866667 0
--0.05 0.9 0
--0.03 0.9 0
--0.05 0.866667 0.3
--0.03 0.866667 0.3
--0.05 0.9 0.3
--0.03 0.9 0.3
--0.03 0.866667 0
--0.01 0.866667 0
--0.03 0.9 0
--0.01 0.9 0
--0.03 0.866667 0.3
--0.01 0.866667 0.3
--0.03 0.9 0.3
--0.01 0.9 0.3
--0.01 0.866667 0
-0.01 0.866667 0
--0.01 0.9 0
-0.01 0.9 0
--0.01 0.866667 0.3
-0.01 0.866667 0.3
--0.01 0.9 0.3
-0.01 0.9 0.3
-0.01 0.866667 0
-0.03 0.866667 0
-0.01 0.9 0
-0.03 0.9 0
-0.01 0.866667 0.3
-0.03 0.866667 0.3
-0.01 0.9 0.3
-0.03 0.9 0.3
-0.03 0.866667 0
-0.05 0.866667 0
-0.03 0.9 0
-0.05 0.9 0
-0.03 0.866667 0.3
-0.05 0.866667 0.3
-0.03 0.9 0.3
-0.05 0.9 0.3
--0.05 0.9 0
--0.03 0.9 0
--0.05 0.933333 0
--0.03 0.933333 0
--0.05 0.9 0.3
--0.03 0.9 0.3
--0.05 0.933333 0.3
--0.03 0.933333 0.3
--0.03 0.9 0
--0.01 0.9 0
--0.03 0.933333 0
--0.01 0.933333 0
--0.03 0.9 0.3
--0.01 0.9 0.3
--0.03 0.933333 0.3
--0.01 0.933333 0.3
--0.01 0.9 0
-0.01 0.9 0
--0.01 0.933333 0
-0.01 0.933333 0
--0.01 0.9 0.3
-0.01 0.9 0.3
--0.01 0.933333 0.3
-0.01 0.933333 0.3
-0.01 0.9 0
-0.03 0.9 0
-0.01 0.933333 0
-0.03 0.933333 0
-0.01 0.9 0.3
-0.03 0.9 0.3
-0.01 0.933333 0.3
-0.03 0.933333 0.3
-0.03 0.9 0
-0.05 0.9 0
-0.03 0.933333 0
-0.05 0.933333 0
-0.03 0.9 0.3
-0.05 0.9 0.3
-0.03 0.933333 0.3
-0.05 0.933333 0.3
--0.05 0.933333 0
--0.03 0.933333 0
--0.05 0.966667 0
--0.03 0.966667 0
--0.05 0.933333 0.3
--0.03 0.933333 0.3
--0.05 0.966667 0.3
--0.03 0.966667 0.3
--0.03 0.933333 0
--0.01 0.933333 0
--0.03 0.966667 0
--0.01 0.966667 0
--0.03 0.933333 0.3
--0.01 0.933333 0.3
--0.03 0.966667 0.3
--0.01 0.966667 0.3
--0.01 0.933333 0
-0.01 0.933333 0
--0.01 0.966667 0
-0.01 0.966667 0
--0.01 0.933333 0.3
-0.01 0.933333 0.3
--0.01 0.966667 0.3
-0.01 0.966667 0.3
-0.01 0.933333 0
-0.03 0.933333 0
-0.01 0.966667 0
-0.03 0.966667 0
-0.01 0.933333 0.3
-0.03 0.933333 0.3
-0.01 0.966667 0.3
-0.03 0.966667 0.3
-0.03 0.933333 0
-0.05 0.933333 0
-0.03 0.966667 0
-0.05 0.966667 0
-0.03 0.933333 0.3
-0.05 0.933333 0.3
-0.03 0.966667 0.3
-0.05 0.966667 0.3
--0.05 0.966667 0
--0.03 0.966667 0
--0.05 1 0
--0.03 1 0
--0.05 0.966667 0.3
--0.03 0.966667 0.3
--0.05 1 0.3
--0.03 1 0.3
--0.03 0.966667 0
--0.01 0.966667 0
--0.03 1 0
--0.01 1 0
--0.03 0.966667 0.3
--0.01 0.966667 0.3
--0.03 1 0.3
--0.01 1 0.3
--0.01 0.966667 0
-0.01 0.966667 0
--0.01 1 0
-0.01 1 0
--0.01 0.966667 0.3
-0.01 0.966667 0.3
--0.01 1 0.3
-0.01 1 0.3
-0.01 0.966667 0
-0.03 0.966667 0
-0.01 1 0
-0.03 1 0
-0.01 0.966667 0.3
-0.03 0.966667 0.3
-0.01 1 0.3
-0.03 1 0.3
-0.03 0.966667 0
-0.05 0.966667 0
-0.03 1 0
-0.05 1 0
-0.03 0.966667 0.3
-0.05 0.966667 0.3
-0.03 1 0.3
-0.05 1 0.3
-
-CELLS 150 1350
-8 0 1 3 2 4 5 7 6
-8 8 9 11 10 12 13 15 14
-8 16 17 19 18 20 21 23 22
-8 24 25 27 26 28 29 31 30
-8 32 33 35 34 36 37 39 38
-8 40 41 43 42 44 45 47 46
-8 48 49 51 50 52 53 55 54
-8 56 57 59 58 60 61 63 62
-8 64 65 67 66 68 69 71 70
-8 72 73 75 74 76 77 79 78
-8 80 81 83 82 84 85 87 86
-8 88 89 91 90 92 93 95 94
-8 96 97 99 98 100 101 103 102
-8 104 105 107 106 108 109 111 110
-8 112 113 115 114 116 117 119 118
-8 120 121 123 122 124 125 127 126
-8 128 129 131 130 132 133 135 134
-8 136 137 139 138 140 141 143 142
-8 144 145 147 146 148 149 151 150
-8 152 153 155 154 156 157 159 158
-8 160 161 163 162 164 165 167 166
-8 168 169 171 170 172 173 175 174
-8 176 177 179 178 180 181 183 182
-8 184 185 187 186 188 189 191 190
-8 192 193 195 194 196 197 199 198
-8 200 201 203 202 204 205 207 206
-8 208 209 211 210 212 213 215 214
-8 216 217 219 218 220 221 223 222
-8 224 225 227 226 228 229 231 230
-8 232 233 235 234 236 237 239 238
-8 240 241 243 242 244 245 247 246
-8 248 249 251 250 252 253 255 254
-8 256 257 259 258 260 261 263 262
-8 264 265 267 266 268 269 271 270
-8 272 273 275 274 276 277 279 278
-8 280 281 283 282 284 285 287 286
-8 288 289 291 290 292 293 295 294
-8 296 297 299 298 300 301 303 302
-8 304 305 307 306 308 309 311 310
-8 312 313 315 314 316 317 319 318
-8 320 321 323 322 324 325 327 326
-8 328 329 331 330 332 333 335 334
-8 336 337 339 338 340 341 343 342
-8 344 345 347 346 348 349 351 350
-8 352 353 355 354 356 357 359 358
-8 360 361 363 362 364 365 367 366
-8 368 369 371 370 372 373 375 374
-8 376 377 379 378 380 381 383 382
-8 384 385 387 386 388 389 391 390
-8 392 393 395 394 396 397 399 398
-8 400 401 403 402 404 405 407 406
-8 408 409 411 410 412 413 415 414
-8 416 417 419 418 420 421 423 422
-8 424 425 427 426 428 429 431 430
-8 432 433 435 434 436 437 439 438
-8 440 441 443 442 444 445 447 446
-8 448 449 451 450 452 453 455 454
-8 456 457 459 458 460 461 463 462
-8 464 465 467 466 468 469 471 470
-8 472 473 475 474 476 477 479 478
-8 480 481 483 482 484 485 487 486
-8 488 489 491 490 492 493 495 494
-8 496 497 499 498 500 501 503 502
-8 504 505 507 506 508 509 511 510
-8 512 513 515 514 516 517 519 518
-8 520 521 523 522 524 525 527 526
-8 528 529 531 530 532 533 535 534
-8 536 537 539 538 540 541 543 542
-8 544 545 547 546 548 549 551 550
-8 552 553 555 554 556 557 559 558
-8 560 561 563 562 564 565 567 566
-8 568 569 571 570 572 573 575 574
-8 576 577 579 578 580 581 583 582
-8 584 585 587 586 588 589 591 590
-8 592 593 595 594 596 597 599 598
-8 600 601 603 602 604 605 607 606
-8 608 609 611 610 612 613 615 614
-8 616 617 619 618 620 621 623 622
-8 624 625 627 626 628 629 631 630
-8 632 633 635 634 636 637 639 638
-8 640 641 643 642 644 645 647 646
-8 648 649 651 650 652 653 655 654
-8 656 657 659 658 660 661 663 662
-8 664 665 667 666 668 669 671 670
-8 672 673 675 674 676 677 679 678
-8 680 681 683 682 684 685 687 686
-8 688 689 691 690 692 693 695 694
-8 696 697 699 698 700 701 703 702
-8 704 705 707 706 708 709 711 710
-8 712 713 715 714 716 717 719 718
-8 720 721 723 722 724 725 727 726
-8 728 729 731 730 732 733 735 734
-8 736 737 739 738 740 741 743 742
-8 744 745 747 746 748 749 751 750
-8 752 753 755 754 756 757 759 758
-8 760 761 763 762 764 765 767 766
-8 768 769 771 770 772 773 775 774
-8 776 777 779 778 780 781 783 782
-8 784 785 787 786 788 789 791 790
-8 792 793 795 794 796 797 799 798
-8 800 801 803 802 804 805 807 806
-8 808 809 811 810 812 813 815 814
-8 816 817 819 818 820 821 823 822
-8 824 825 827 826 828 829 831 830
-8 832 833 835 834 836 837 839 838
-8 840 841 843 842 844 845 847 846
-8 848 849 851 850 852 853 855 854
-8 856 857 859 858 860 861 863 862
-8 864 865 867 866 868 869 871 870
-8 872 873 875 874 876 877 879 878
-8 880 881 883 882 884 885 887 886
-8 888 889 891 890 892 893 895 894
-8 896 897 899 898 900 901 903 902
-8 904 905 907 906 908 909 911 910
-8 912 913 915 914 916 917 919 918
-8 920 921 923 922 924 925 927 926
-8 928 929 931 930 932 933 935 934
-8 936 937 939 938 940 941 943 942
-8 944 945 947 946 948 949 951 950
-8 952 953 955 954 956 957 959 958
-8 960 961 963 962 964 965 967 966
-8 968 969 971 970 972 973 975 974
-8 976 977 979 978 980 981 983 982
-8 984 985 987 986 988 989 991 990
-8 992 993 995 994 996 997 999 998
-8 1000 1001 1003 1002 1004 1005 1007 1006
-8 1008 1009 1011 1010 1012 1013 1015 1014
-8 1016 1017 1019 1018 1020 1021 1023 1022
-8 1024 1025 1027 1026 1028 1029 1031 1030
-8 1032 1033 1035 1034 1036 1037 1039 1038
-8 1040 1041 1043 1042 1044 1045 1047 1046
-8 1048 1049 1051 1050 1052 1053 1055 1054
-8 1056 1057 1059 1058 1060 1061 1063 1062
-8 1064 1065 1067 1066 1068 1069 1071 1070
-8 1072 1073 1075 1074 1076 1077 1079 1078
-8 1080 1081 1083 1082 1084 1085 1087 1086
-8 1088 1089 1091 1090 1092 1093 1095 1094
-8 1096 1097 1099 1098 1100 1101 1103 1102
-8 1104 1105 1107 1106 1108 1109 1111 1110
-8 1112 1113 1115 1114 1116 1117 1119 1118
-8 1120 1121 1123 1122 1124 1125 1127 1126
-8 1128 1129 1131 1130 1132 1133 1135 1134
-8 1136 1137 1139 1138 1140 1141 1143 1142
-8 1144 1145 1147 1146 1148 1149 1151 1150
-8 1152 1153 1155 1154 1156 1157 1159 1158
-8 1160 1161 1163 1162 1164 1165 1167 1166
-8 1168 1169 1171 1170 1172 1173 1175 1174
-8 1176 1177 1179 1178 1180 1181 1183 1182
-8 1184 1185 1187 1186 1188 1189 1191 1190
-8 1192 1193 1195 1194 1196 1197 1199 1198
-
-CELL_TYPES 150
- 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12
-POINT_DATA 1200
-VECTORS displacement double
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-0 0 0
-SCALARS strain_xx double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_xy double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_xz double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_yx double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_yy double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_yz double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_zx double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_zy double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-SCALARS strain_zz double 1
-LOOKUP_TABLE default
-0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Solid/linear_elasticity.prm b/FSI/flap_perp/OpenFOAM-deal.II/Solid/linear_elasticity.prm
deleted file mode 100644
index 5479b5d18..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Solid/linear_elasticity.prm
+++ /dev/null
@@ -1,68 +0,0 @@
-# Listing of Parameters
-# Dimensional quantities are in SI units
-# --------------------------------------
-
-subsection Time
- # End time
- set End time = 5
-
- # Time step size
- set Time step size = 0.01
-
- # Write results every x timesteps
- set Output interval = 10
-end
-
-subsection Discretization
- # Time integration scheme
- # 0 = forward, 1 = backward
- set theta = 0.5
-
- # Polynomial degree of the FE system
- set Polynomial degree = 2
-end
-
-subsection System properties
- # mu (shear modulus)
- set mu = 153846
-
- # lambda
- set lambda = 230769
-
- # density
- set rho = 3000
-
- # body forces x,y,z
- set body forces = 0.0,0.0,0.0
-end
-
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
-
- # Linear solver: CG or Direct
- set Solver type = Direct
-end
-
-subsection precice configuration
- # Cases: FSI3 or PF for perpendicular flap
- set Scenario = PF
-
- # Name of the precice configuration file
- set precice config-file = precice-config.xml
-
- # Name of the participant in the precice-config.xml file
- set Participant name = Solid
-
- # Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
-
- # Name of the read data in the precice-config.xml file
- set Read data name = Stress
-
- # Name of the write data in the precice-config.xml file
- set Write data name = Displacement
-end
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm b/FSI/flap_perp/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
deleted file mode 100644
index ff5b5c83c..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
+++ /dev/null
@@ -1,81 +0,0 @@
-# Listing of Parameters
-# Dimensional quantities are in SI units
-# --------------------------------------
-
-subsection Time
- # End time
- set End time = 5
-
- # Time step size
- set Time step size = 0.01
-
- # Output interval
- set Output interval = 10
-end
-
-subsection Discretization
- # Newmark beta
- set beta = 0.25
-
- # Newmark gamma
- set gamma = 0.5
-
- # Polynomial degree of the FE system
- set Polynomial degree = 2
-end
-
-subsection System properties
- # Poisson's ratio
- set Poisson's ratio = 0.375
-
- # Shear modulus
- set Shear modulus = 153846
-
- # Density
- set rho = 3000
-
- # Body forces x,y,z
- set body forces = 0.0,0.0,0.0
-end
-
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
-
- # Linear solver: CG or Direct
- set Solver type = Direct
-end
-
-subsection Nonlinear solver
- # Number of Newton-Raphson iterations allowed
- set Max iterations Newton-Raphson = 10
-
- # Displacement error tolerance
- set Tolerance displacement = 1.0e-6
-
- # Force residual tolerance
- set Tolerance force = 1.0e-9
-end
-
-subsection precice configuration
- # Cases: FSI3 or PF for perpendicular flap
- set Scenario = PF
-
- # Name of the precice configuration file
- set precice config-file = precice-config.xml
-
- # Name of the participant in the precice-config.xml file
- set Participant name = Solid
-
- # Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
-
- # Name of the read data in the precice-config.xml file
- set Read data name = Stress
-
- # Name of the write data in the precice-config.xml file
- set Write data name = Displacement
-end
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/plotDisplacement.sh b/FSI/flap_perp/OpenFOAM-deal.II/plotDisplacement.sh
deleted file mode 100755
index c83fa1dde..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/plotDisplacement.sh
+++ /dev/null
@@ -1,13 +0,0 @@
-#! /bin/bash
-gnuplot -p << EOF
-set grid
-set title 'Displacement of the Flap Tip'
-set xlabel 'Time [s]'
-set ylabel 'X-Displacement [m]'
-# set style line 1 lt 2 lw 6
-# set style line 1 lt 2 lw 6
-# set linestyle 2 lt 2 lc 1 # red-dashed
-set linestyle 1 lt 2 lc 1 # red-dashed
-plot "precice-Solid-watchpoint-flap_tip.log" using 1:4 title 'Top displacemement' with lines
-EOF
-
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/precice-config.xml b/FSI/flap_perp/OpenFOAM-deal.II/precice-config.xml
deleted file mode 100644
index 208a87c90..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/precice-config.xml
+++ /dev/null
@@ -1,83 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/removeObsoleteFolders.sh b/FSI/flap_perp/OpenFOAM-deal.II/removeObsoleteFolders.sh
deleted file mode 100755
index 6866c8c42..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,22 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/runFluid b/FSI/flap_perp/OpenFOAM-deal.II/runFluid
deleted file mode 100755
index 1a5b143a6..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/runFluid
+++ /dev/null
@@ -1,45 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the execute the coupled_elasto_dynamics binary
-# in another terminal.
-# These scripts present how the two participants would be started manually.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- solver=$(getApplication)
- procs=$(getNumberOfProcessors)
-cd ..
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $procs $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26 (OF-adapter, relevant for OF .com versions)
-./removeObsoleteFolders.sh
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/runSolid b/FSI/flap_perp/OpenFOAM-deal.II/runSolid
deleted file mode 100755
index 7e6fe12c3..000000000
--- a/FSI/flap_perp/OpenFOAM-deal.II/runSolid
+++ /dev/null
@@ -1,27 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-
-# Solid participant
-
-# Run this script in one terminal and the execute the Fluid participant
-# in another terminal.
-# These scripts present how the two participants would be started manually.
-
-# 1 for true, 0 for false
-nonlinear=0
-if [ "$1" = "-nonlinear" ]; then
- nonlinear=1
-fi
-
-linear=0
-if [ "$1" = "-linear" ]; then
- linear=1
-fi
-
-if [ $linear -eq 1 ]; then
- ./linear_elasticity Solid/linear_elasticity.prm
-elif [ $nonlinear -eq 1 ]; then
- ./nonlinear_elasticity Solid/nonlinear_elasticity.prm
-else
- echo "No solver type specified. Please specify -linear or -nonlinear as solver type"
-fi
diff --git a/FSI/flap_perp/SU2-CalculiX/Fluid/euler_config_coupled.cfg b/FSI/flap_perp/SU2-CalculiX/Fluid/euler_config_coupled.cfg
deleted file mode 100644
index 304104c91..000000000
--- a/FSI/flap_perp/SU2-CalculiX/Fluid/euler_config_coupled.cfg
+++ /dev/null
@@ -1,267 +0,0 @@
-%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
-% %
-% SU2 configuration file %
-% Case description: Coupled FSI simulation of fluid flow over a flap %
-% Authors: Kirill Martynov, Dmytro Sashko, Jan Sültemeyer %
-% Institution: Technische Universität München %
-% Date: 01.11.2017 %
-% %
-%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
-
-% ------------- PRECICE PROBLEM DEFINITION ------------%
-
-PRECICE_USAGE= YES
-%
-PRECICE_CONFIG_FILENAME= ./precice-config.xml
-%
-PRECICE_WETSURFACE_MARKER_NAME= wetSurface
-%
-PRECICE_NUMBER_OF_WETSURFACES= 1
-
-% ------------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION ------------%
-
-% Physical governing equations (EULER, NAVIER_STOKES, NS_PLASMA)
-PHYSICAL_PROBLEM= EULER
-%
-% Mathematical problem (DIRECT, CONTINUOUS_ADJOINT)
-MATH_PROBLEM= DIRECT
-%
-% Restart solution (NO, YES)
-RESTART_SOL= YES
-
-% -------------------- COMPRESSIBLE FREE-STREAM DEFINITION --------------------%
-
-% Mach number (non-dimensional, based on the free-stream values)
-MACH_NUMBER= 0.01
-%
-% Angle of attack (degrees, only for compressible flows)
-AOA= 0.0
-%
-% Side-slip angle (degrees, only for compressible flows)
-SIDESLIP_ANGLE= 0.0
-%
-% Free-stream pressure (101325.0 N/m^2 by default)
-FREESTREAM_PRESSURE= 101300.0
-%
-% Free-stream temperature (288.15 K by default)
-FREESTREAM_TEMPERATURE= 288.0
-
-% ------------------------- UNSTEADY SIMULATION -------------------------------%
-
-% Unsteady simulation (NO, TIME_STEPPING, DUAL_TIME_STEPPING-1ST_ORDER,
-% DUAL_TIME_STEPPING-2ND_ORDER, TIME_SPECTRAL)
-UNSTEADY_SIMULATION= DUAL_TIME_STEPPING-1ST_ORDER
-%
-% Time Step for dual time stepping simulations (s)
-UNST_TIMESTEP= 0.01
-%
-% Total Physical Time for dual time stepping simulations (s)
-UNST_TIME= 6.0
-%
-% Number of internal iterations (dual time method)
-UNST_INT_ITER= 200
-%
-% Iteration number to begin unsteady restarts
-UNST_RESTART_ITER= 1
-
-% ----------------------- DYNAMIC MESH DEFINITION -----------------------------%
-
-% Dynamic mesh simulation (NO, YES)
-GRID_MOVEMENT= YES
-%
-% Type of dynamic mesh (NONE, RIGID_MOTION, DEFORMING, ROTATING_FRAME,
-% MOVING_WALL, STEADY_TRANSLATION, FLUID_STRUCTURE,
-% AEROELASTIC, ELASTICITY, EXTERNAL,
-% AEROELASTIC_RIGID_MOTION, GUST, PRECICE_MOVEMENT)
-GRID_MOVEMENT_KIND= PRECICE_MOVEMENT
-%
-% Moving wall boundary marker(s) (NONE = no marker, ignored for RIGID_MOTION)
-MARKER_MOVING= ( wetSurface0 )
-
-% -------------------- BOUNDARY CONDITION DEFINITION --------------------------%
-
-% Euler wall boundary marker(s) (NONE = no marker)
-MARKER_EULER= ( upper_wall, lower_wall, wetSurface0 )
-%
-% Inlet boundary marker(s) (NONE = no marker)
-% Format: ( inlet marker, total temperature, total pressure, flow_direction_x,
-% flow_direction_y, flow_direction_z, ... ) where flow_direction is
-% a unit vector.
-MARKER_INLET= ( inlet, 288.6, 101400.0, 1.0, 0.0, 0.0 )
-%
-% Outlet boundary marker(s) (NONE = no marker)
-% Format: ( outlet marker, back pressure (static), ... )
-MARKER_OUTLET= ( outlet, 101300.0 )
-%
-% Symmetry boundary marker for quasi-2D simulation
-MARKER_SYM = ( symmetry )
-
-% ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------%
-
-% Numerical method for spatial gradients (GREEN_GAUSS, WEIGHTED_LEAST_SQUARES)
-NUM_METHOD_GRAD= GREEN_GAUSS
-%
-% Courant-Friedrichs-Lewy condition of the finest grid
-CFL_NUMBER= 2.0
-%
-% Adaptive CFL number (NO, YES)
-CFL_ADAPT= NO
-%
-% Parameters of the adaptive CFL number (factor down, factor up, CFL min value,
-% CFL max value )
-CFL_ADAPT_PARAM= ( 1.5, 0.5, 1.0, 100.0 )
-%
-% Runge-Kutta alpha coefficients
-RK_ALPHA_COEFF= ( 0.66667, 0.66667, 1.000000 )
-%
-% Number of total iterations
-EXT_ITER= 999999
-
-% ------------------------ LINEAR SOLVER DEFINITION ---------------------------%
-
-% Linear solver for implicit formulations (BCGSTAB, FGMRES)
-LINEAR_SOLVER= FGMRES
-%
-% Preconditioner of the Krylov linear solver (JACOBI, LINELET, LU_SGS)
-LINEAR_SOLVER_PREC= LU_SGS
-%
-% Minimum error of the linear solver for implicit formulations
-LINEAR_SOLVER_ERROR= 1E-4
-%
-% Max number of iterations of the linear solver for the implicit formulation
-LINEAR_SOLVER_ITER= 20
-
-% -------------------------- MULTIGRID PARAMETERS -----------------------------%
-
-% Multi-Grid Levels (0 = no multi-grid)
-MGLEVEL= 3
-%
-% Multi-grid cycle (V_CYCLE, W_CYCLE, FULLMG_CYCLE)
-MGCYCLE= V_CYCLE
-%
-% Multi-grid pre-smoothing level
-MG_PRE_SMOOTH= ( 1, 2, 3, 3 )
-%
-% Multi-grid post-smoothing level
-MG_POST_SMOOTH= ( 0, 0, 0, 0 )
-%
-% Jacobi implicit smoothing of the correction
-MG_CORRECTION_SMOOTH= ( 0, 0, 0, 0 )
-%
-% Damping factor for the residual restriction
-MG_DAMP_RESTRICTION= 0.9
-%
-% Damping factor for the correction prolongation
-MG_DAMP_PROLONGATION= 0.9
-
-% -------------------- FLOW NUMERICAL METHOD DEFINITION -----------------------%
-
-% Convective numerical method (JST, LAX-FRIEDRICH, CUSP, ROE, AUSM, HLLC,
-% TURKEL_PREC, MSW)
-CONV_NUM_METHOD_FLOW= JST
-%
-% Monotonic Upwind Scheme for Conservation Laws (TVD) in the flow equations.
-% Required for 2nd order upwind schemes (NO, YES)
-MUSCL_FLOW= YES
-%
-% Slope limiter (NONE, VENKATAKRISHNAN, VENKATAKRISHNAN_WANG,
-% BARTH_JESPERSEN, VAN_ALBADA_EDGE)
-SLOPE_LIMITER_FLOW= VENKATAKRISHNAN
-%
-% Coefficient for the Venkat's limiter (upwind scheme). A larger values decrease
-% the extent of limiting, values approaching zero cause
-% lower-order approximation to the solution (0.05 by default)
-VENKAT_LIMITER_COEFF= 0.05
-%
-% 2nd and 4th order artificial dissipation coefficients for
-% the JST method ( 0.5, 0.02 by default )
-JST_SENSOR_COEFF= ( 0.5, 0.02 )
-%
-% Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT, EULER_EXPLICIT)
-TIME_DISCRE_FLOW= EULER_IMPLICIT
-
-% --------------------------- CONVERGENCE PARAMETERS --------------------------%
-
-% Convergence criteria (CAUCHY, RESIDUAL)
-%
-CONV_CRITERIA= RESIDUAL
-%
-% Residual reduction (order of magnitude with respect to the initial value)
-RESIDUAL_REDUCTION= 1
-%
-% Min value of the residual (log10 of the residual)
-RESIDUAL_MINVAL= -3.5
-%
-% Start convergence criteria at iteration number
-STARTCONV_ITER= 10
-
-% ------------------------- INPUT/OUTPUT INFORMATION --------------------------%
-
-% Write residuals
-WRT_RESIDUALS= YES
-%
-% Mesh input file
-MESH_FILENAME= Fluid/fluidMesh.su2
-%
-% Mesh input file format (SU2, CGNS, NETCDF_ASCII)
-MESH_FORMAT= SU2
-%
-% Restart flow input file
-SOLUTION_FLOW_FILENAME= Fluid/initial_flow.dat
-%
-% Output file format (PARAVIEW, TECPLOT, STL)
-OUTPUT_FORMAT= PARAVIEW
-%
-% Output file convergence history (w/o extension)
-CONV_FILENAME= history
-%
-% Write binary restart files (YES, NO)
-WRT_BINARY_RESTART= NO
-%
-% Read binary restart files (YES, NO)
-READ_BINARY_RESTART= NO
-%
-% Output file flow (w/o extension) variables
-VOLUME_FLOW_FILENAME= flow
-%
-% Write surface solution files
-WRT_SRF_SOL= NO
-%
-% Writing solution file frequency
-WRT_SOL_FREQ= 1
-%
-% Writing solution file frequency for physical time steps (dual time)
-WRT_SOL_FREQ_DUALTIME= 1
-%
-% Writing convergence history frequency
-WRT_CON_FREQ= 1
-%
-% Writing convergence history frequency
-WRT_CON_FREQ_DUALTIME= 1
-
-% ------------------------ GRID DEFORMATION PARAMETERS ------------------------%
-%
-% Linear solver or smoother for implicit formulations (FGMRES, RESTARTED_FGMRES, BCGSTAB)
-DEFORM_LINEAR_SOLVER= FGMRES
-%
-% Preconditioner of the Krylov linear solver (ILU, LU_SGS, JACOBI)
-DEFORM_LINEAR_SOLVER_PREC= LU_SGS
-%
-% Number of smoothing iterations for mesh deformation
-DEFORM_LINEAR_ITER= 50
-%
-% Number of nonlinear deformation iterations (surface deformation increments)
-DEFORM_NONLINEAR_ITER= 1
-%
-% Print the residuals during mesh deformation to the console (YES, NO)
-%DEFORM_CONSOLE_OUTPUT= NO
-%
-% Factor to multiply smallest cell volume for deform tolerance (0.001 default)
-DEFORM_TOL_FACTOR = 0.1
-%
-% Type of element stiffness imposed for FEA mesh deformation (INVERSE_VOLUME,
-% WALL_DISTANCE, CONSTANT_STIFFNESS)
-DEFORM_STIFFNESS_TYPE= INVERSE_VOLUME
-%
-% Visualize the deformation (NO, YES)
-%VISUALIZE_DEFORMATION= YES
diff --git a/FSI/flap_perp/SU2-CalculiX/Fluid/euler_config_coupled_mergeSolution.cfg b/FSI/flap_perp/SU2-CalculiX/Fluid/euler_config_coupled_mergeSolution.cfg
deleted file mode 100644
index 7847e818b..000000000
--- a/FSI/flap_perp/SU2-CalculiX/Fluid/euler_config_coupled_mergeSolution.cfg
+++ /dev/null
@@ -1,267 +0,0 @@
-%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
-% %
-% SU2 configuration file %
-% Case description: Coupled FSI simulation of fluid flow over a flap %
-% Authors: Kirill Martynov, Dmytro Sashko, Jan Sültemeyer %
-% Institution: Technische Universität München %
-% Date: 01.11.2017 %
-% %
-%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
-
-% ------------- PRECICE PROBLEM DEFINITION ------------%
-
-PRECICE_USAGE= YES
-%
-PRECICE_CONFIG_FILENAME= ./precice-config.xml
-%
-PRECICE_WETSURFACE_MARKER_NAME= wetSurface
-%
-PRECICE_NUMBER_OF_WETSURFACES= 1
-
-% ------------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION ------------%
-
-% Physical governing equations (EULER, NAVIER_STOKES, NS_PLASMA)
-PHYSICAL_PROBLEM= EULER
-%
-% Mathematical problem (DIRECT, CONTINUOUS_ADJOINT)
-MATH_PROBLEM= DIRECT
-%
-% Restart solution (NO, YES)
-RESTART_SOL= YES
-
-% -------------------- COMPRESSIBLE FREE-STREAM DEFINITION --------------------%
-
-% Mach number (non-dimensional, based on the free-stream values)
-MACH_NUMBER= 0.01
-%
-% Angle of attack (degrees, only for compressible flows)
-AOA= 0.0
-%
-% Side-slip angle (degrees, only for compressible flows)
-SIDESLIP_ANGLE= 0.0
-%
-% Free-stream pressure (101325.0 N/m^2 by default)
-FREESTREAM_PRESSURE= 101300.0
-%
-% Free-stream temperature (288.15 K by default)
-FREESTREAM_TEMPERATURE= 288.0
-
-% ------------------------- UNSTEADY SIMULATION -------------------------------%
-
-% Unsteady simulation (NO, TIME_STEPPING, DUAL_TIME_STEPPING-1ST_ORDER,
-% DUAL_TIME_STEPPING-2ND_ORDER, TIME_SPECTRAL)
-UNSTEADY_SIMULATION= DUAL_TIME_STEPPING-1ST_ORDER
-%
-% Time Step for dual time stepping simulations (s)
-UNST_TIMESTEP= 0.01
-%
-% Total Physical Time for dual time stepping simulations (s)
-UNST_TIME= 4.01
-%
-% Number of internal iterations (dual time method)
-UNST_INT_ITER= 200
-%
-% Iteration number to begin unsteady restarts
-UNST_RESTART_ITER= 1
-
-% ----------------------- DYNAMIC MESH DEFINITION -----------------------------%
-
-% Dynamic mesh simulation (NO, YES)
-GRID_MOVEMENT= YES
-%
-% Type of dynamic mesh (NONE, RIGID_MOTION, DEFORMING, ROTATING_FRAME,
-% MOVING_WALL, STEADY_TRANSLATION, FLUID_STRUCTURE,
-% AEROELASTIC, ELASTICITY, EXTERNAL,
-% AEROELASTIC_RIGID_MOTION, GUST, PRECICE_MOVEMENT)
-GRID_MOVEMENT_KIND= PRECICE_MOVEMENT
-%
-% Moving wall boundary marker(s) (NONE = no marker, ignored for RIGID_MOTION)
-MARKER_MOVING= ( wetSurface0 )
-
-% -------------------- BOUNDARY CONDITION DEFINITION --------------------------%
-
-% Euler wall boundary marker(s) (NONE = no marker)
-MARKER_EULER= ( upper_wall, lower_wall, wetSurface0 )
-%
-% Inlet boundary marker(s) (NONE = no marker)
-% Format: ( inlet marker, total temperature, total pressure, flow_direction_x,
-% flow_direction_y, flow_direction_z, ... ) where flow_direction is
-% a unit vector.
-MARKER_INLET= ( inlet, 288.6, 101400.0, 1.0, 0.0, 0.0 )
-%
-% Outlet boundary marker(s) (NONE = no marker)
-% Format: ( outlet marker, back pressure (static), ... )
-MARKER_OUTLET= ( outlet, 101300.0 )
-%
-% Symmetry boundary marker for quasi-2D simulation
-MARKER_SYM = ( symmetry )
-
-% ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------%
-
-% Numerical method for spatial gradients (GREEN_GAUSS, WEIGHTED_LEAST_SQUARES)
-NUM_METHOD_GRAD= GREEN_GAUSS
-%
-% Courant-Friedrichs-Lewy condition of the finest grid
-CFL_NUMBER= 2.0
-%
-% Adaptive CFL number (NO, YES)
-CFL_ADAPT= NO
-%
-% Parameters of the adaptive CFL number (factor down, factor up, CFL min value,
-% CFL max value )
-CFL_ADAPT_PARAM= ( 1.5, 0.5, 1.0, 100.0 )
-%
-% Runge-Kutta alpha coefficients
-RK_ALPHA_COEFF= ( 0.66667, 0.66667, 1.000000 )
-%
-% Number of total iterations
-EXT_ITER= 999999
-
-% ------------------------ LINEAR SOLVER DEFINITION ---------------------------%
-
-% Linear solver for implicit formulations (BCGSTAB, FGMRES)
-LINEAR_SOLVER= FGMRES
-%
-% Preconditioner of the Krylov linear solver (JACOBI, LINELET, LU_SGS)
-LINEAR_SOLVER_PREC= LU_SGS
-%
-% Minimum error of the linear solver for implicit formulations
-LINEAR_SOLVER_ERROR= 1E-4
-%
-% Max number of iterations of the linear solver for the implicit formulation
-LINEAR_SOLVER_ITER= 20
-
-% -------------------------- MULTIGRID PARAMETERS -----------------------------%
-
-% Multi-Grid Levels (0 = no multi-grid)
-MGLEVEL= 3
-%
-% Multi-grid cycle (V_CYCLE, W_CYCLE, FULLMG_CYCLE)
-MGCYCLE= V_CYCLE
-%
-% Multi-grid pre-smoothing level
-MG_PRE_SMOOTH= ( 1, 2, 3, 3 )
-%
-% Multi-grid post-smoothing level
-MG_POST_SMOOTH= ( 0, 0, 0, 0 )
-%
-% Jacobi implicit smoothing of the correction
-MG_CORRECTION_SMOOTH= ( 0, 0, 0, 0 )
-%
-% Damping factor for the residual restriction
-MG_DAMP_RESTRICTION= 0.9
-%
-% Damping factor for the correction prolongation
-MG_DAMP_PROLONGATION= 0.9
-
-% -------------------- FLOW NUMERICAL METHOD DEFINITION -----------------------%
-
-% Convective numerical method (JST, LAX-FRIEDRICH, CUSP, ROE, AUSM, HLLC,
-% TURKEL_PREC, MSW)
-CONV_NUM_METHOD_FLOW= JST
-%
-% Monotonic Upwind Scheme for Conservation Laws (TVD) in the flow equations.
-% Required for 2nd order upwind schemes (NO, YES)
-MUSCL_FLOW= YES
-%
-% Slope limiter (NONE, VENKATAKRISHNAN, VENKATAKRISHNAN_WANG,
-% BARTH_JESPERSEN, VAN_ALBADA_EDGE)
-SLOPE_LIMITER_FLOW= VENKATAKRISHNAN
-%
-% Coefficient for the Venkat's limiter (upwind scheme). A larger values decrease
-% the extent of limiting, values approaching zero cause
-% lower-order approximation to the solution (0.05 by default)
-VENKAT_LIMITER_COEFF= 0.05
-%
-% 2nd and 4th order artificial dissipation coefficients for
-% the JST method ( 0.5, 0.02 by default )
-JST_SENSOR_COEFF= ( 0.5, 0.02 )
-%
-% Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT, EULER_EXPLICIT)
-TIME_DISCRE_FLOW= EULER_IMPLICIT
-
-% --------------------------- CONVERGENCE PARAMETERS --------------------------%
-
-% Convergence criteria (CAUCHY, RESIDUAL)
-%
-CONV_CRITERIA= RESIDUAL
-%
-% Residual reduction (order of magnitude with respect to the initial value)
-RESIDUAL_REDUCTION= 1
-%
-% Min value of the residual (log10 of the residual)
-RESIDUAL_MINVAL= -3.5
-%
-% Start convergence criteria at iteration number
-STARTCONV_ITER= 10
-
-% ------------------------- INPUT/OUTPUT INFORMATION --------------------------%
-
-% Write residuals
-WRT_RESIDUALS= YES
-%
-% Mesh input file
-MESH_FILENAME= Fluid/fluidMesh.su2
-%
-% Mesh input file format (SU2, CGNS, NETCDF_ASCII)
-MESH_FORMAT= SU2
-%
-% Restart flow input file
-SOLUTION_FLOW_FILENAME= Fluid/restart_flow.dat
-%
-% Output file format (PARAVIEW, TECPLOT, STL)
-OUTPUT_FORMAT= PARAVIEW
-%
-% Output file convergence history (w/o extension)
-CONV_FILENAME= history
-%
-% Write binary restart files (YES, NO)
-WRT_BINARY_RESTART= NO
-%
-% Read binary restart files (YES, NO)
-READ_BINARY_RESTART= NO
-%
-% Output file flow (w/o extension) variables
-VOLUME_FLOW_FILENAME= flow
-%
-% Write surface solution files
-WRT_SRF_SOL= NO
-%
-% Writing solution file frequency
-WRT_SOL_FREQ= 1
-%
-% Writing solution file frequency for physical time steps (dual time)
-WRT_SOL_FREQ_DUALTIME= 1
-%
-% Writing convergence history frequency
-WRT_CON_FREQ= 1
-%
-% Writing convergence history frequency
-WRT_CON_FREQ_DUALTIME= 1
-
-% ------------------------ GRID DEFORMATION PARAMETERS ------------------------%
-%
-% Linear solver or smoother for implicit formulations (FGMRES, RESTARTED_FGMRES, BCGSTAB)
-DEFORM_LINEAR_SOLVER= FGMRES
-%
-% Preconditioner of the Krylov linear solver (ILU, LU_SGS, JACOBI)
-DEFORM_LINEAR_SOLVER_PREC= LU_SGS
-%
-% Number of smoothing iterations for mesh deformation
-DEFORM_LINEAR_ITER= 50
-%
-% Number of nonlinear deformation iterations (surface deformation increments)
-DEFORM_NONLINEAR_ITER= 1
-%
-% Print the residuals during mesh deformation to the console (YES, NO)
-%DEFORM_CONSOLE_OUTPUT= NO
-%
-% Factor to multiply smallest cell volume for deform tolerance (0.001 default)
-DEFORM_TOL_FACTOR = 0.1
-%
-% Type of element stiffness imposed for FEA mesh deformation (INVERSE_VOLUME,
-% WALL_DISTANCE, CONSTANT_STIFFNESS)
-DEFORM_STIFFNESS_TYPE= INVERSE_VOLUME
-%
-% Visualize the deformation (NO, YES)
-%VISUALIZE_DEFORMATION= YES
diff --git a/FSI/flap_perp/SU2-CalculiX/Fluid/fluidMesh.su2 b/FSI/flap_perp/SU2-CalculiX/Fluid/fluidMesh.su2
deleted file mode 100644
index 8a68bb99a..000000000
--- a/FSI/flap_perp/SU2-CalculiX/Fluid/fluidMesh.su2
+++ /dev/null
@@ -1,1080 +0,0 @@
-NDIME= 3
-NELEM= 247
-13 167 109 106 273 215 212 0
-13 107 108 168 213 214 274 1
-13 100 82 119 206 188 225 2
-13 118 83 101 224 189 207 3
-13 167 106 25 273 212 54 4
-13 24 107 168 53 213 274 5
-13 110 77 84 216 183 190 6
-13 84 77 111 190 183 217 7
-13 92 78 132 198 184 238 8
-13 106 82 117 212 188 223 9
-13 116 83 107 222 189 213 10
-13 110 80 137 216 186 243 11
-13 142 78 96 248 184 202 12
-13 97 79 143 203 185 249 13
-13 123 82 100 229 188 206 14
-13 101 83 124 207 189 230 15
-13 26 25 106 55 54 212 16
-13 24 23 107 53 52 213 17
-13 167 4 115 273 11 221 18
-13 114 3 168 220 10 274 19
-13 99 35 152 205 64 258 20
-13 151 43 98 257 72 204 21
-13 153 79 94 259 185 200 22
-13 122 76 132 228 182 238 23
-13 112 86 118 218 192 224 24
-13 119 85 113 225 191 219 25
-13 119 74 100 225 180 206 26
-13 101 75 118 207 181 224 27
-13 132 78 93 238 184 199 28
-13 107 86 108 213 192 214 29
-13 109 85 106 215 191 212 30
-13 135 80 89 241 186 195 31
-13 90 81 136 196 187 242 32
-13 139 82 106 245 188 212 33
-13 107 83 138 213 189 244 34
-13 137 80 130 243 186 236 35
-13 117 82 104 223 188 210 36
-13 105 83 116 211 189 222 37
-13 112 75 171 218 181 277 38
-13 172 74 113 278 180 219 39
-13 95 79 153 201 185 259 40
-13 120 75 101 226 181 207 41
-13 100 74 121 206 180 227 42
-13 148 88 125 254 194 231 43
-13 126 87 147 232 193 253 44
-13 125 33 148 231 62 254 45
-13 147 16 126 253 45 232 46
-13 164 78 142 270 184 248 47
-13 143 79 165 249 185 271 48
-13 115 4 163 221 11 269 49
-13 162 3 114 268 10 220 50
-13 35 34 152 64 63 258 51
-13 44 43 151 73 72 257 52
-13 113 85 136 219 191 242 53
-13 135 86 112 241 192 218 54
-13 100 31 123 206 60 229 55
-13 124 18 101 230 47 207 56
-13 107 23 116 213 52 222 57
-13 117 26 106 223 55 212 58
-13 112 80 135 218 186 241 59
-13 136 81 113 242 187 219 60
-13 110 84 145 216 190 251 61
-13 146 84 111 252 190 217 62
-13 171 75 133 277 181 239 63
-13 134 74 172 240 180 278 64
-13 132 93 122 238 199 228 65
-13 155 100 121 261 206 227 66
-13 120 101 154 226 207 260 67
-13 19 18 124 48 47 230 68
-13 31 30 123 60 59 229 69
-13 162 114 145 268 220 251 70
-13 146 115 163 252 221 269 71
-13 33 32 148 62 61 254 72
-13 17 16 147 46 45 253 73
-13 136 109 115 242 215 221 74
-13 114 108 135 220 214 241 75
-13 125 6 33 231 13 62 76
-13 16 0 126 45 8 232 77
-13 149 37 102 255 66 208 78
-13 103 41 150 209 70 256 79
-13 93 78 174 199 184 280 80
-13 173 79 95 279 185 201 81
-13 145 89 110 251 195 216 82
-13 111 90 146 217 196 252 83
-13 136 85 109 242 191 215 84
-13 108 86 135 214 192 241 85
-13 32 31 155 61 60 261 86
-13 18 17 154 47 46 260 87
-13 115 109 167 221 215 273 88
-13 168 108 114 274 214 220 89
-13 156 5 28 262 12 57 90
-13 21 2 159 50 9 265 91
-13 176 76 122 282 182 228 92
-13 29 5 156 58 12 262 93
-13 159 2 20 265 9 49 94
-13 20 19 160 49 48 266 95
-13 30 29 157 59 58 263 96
-13 23 22 116 52 51 222 97
-13 27 26 117 56 55 223 98
-13 143 88 134 249 194 240 99
-13 133 87 142 239 193 248 100
-13 126 0 44 232 8 73 101
-13 34 6 125 63 13 231 102
-13 118 75 112 224 181 218 103
-13 113 74 119 219 180 225 104
-13 89 80 110 195 186 216 105
-13 111 81 90 217 187 196 106
-13 138 86 107 244 192 213 107
-13 106 85 139 212 191 245 108
-13 155 31 100 261 60 206 109
-13 101 18 154 207 47 260 110
-13 102 37 170 208 66 276 111
-13 169 41 103 275 70 209 112
-13 155 121 148 261 227 254 113
-13 147 120 154 253 226 260 114
-13 118 86 138 224 192 244 115
-13 139 85 119 245 191 225 116
-13 163 91 146 269 197 252 117
-13 145 91 162 251 197 268 118
-13 130 78 92 236 184 198 119
-13 94 79 131 200 185 237 120
-13 134 88 121 240 194 227 121
-13 120 87 133 226 193 239 122
-13 130 92 137 236 198 243 123
-13 38 37 149 67 66 255 124
-13 41 40 150 70 69 256 125
-13 98 43 128 204 72 234 126
-13 127 35 99 233 64 205 127
-13 96 78 130 202 184 236 128
-13 131 79 97 237 185 203 129
-13 127 102 170 233 208 276 130
-13 169 103 128 275 209 234 131
-13 142 98 164 248 204 270 132
-13 165 99 143 271 205 249 133
-13 36 35 127 65 64 233 134
-13 43 42 128 72 71 234 135
-13 104 82 158 210 188 264 136
-13 161 83 105 267 189 211 137
-13 123 30 158 229 59 264 138
-13 161 19 124 267 48 230 139
-13 128 42 169 234 71 275 140
-13 170 36 127 276 65 233 141
-13 4 3 140 11 10 246 142
-13 40 39 175 69 68 281 143
-13 116 22 178 222 51 284 144
-13 177 27 117 283 56 223 145
-13 152 88 143 258 194 249 146
-13 142 87 151 248 193 257 147
-13 133 75 120 239 181 226 148
-13 121 74 134 227 180 240 149
-13 158 30 157 264 59 263 150
-13 160 19 161 266 48 267 151
-13 39 38 144 68 67 250 152
-13 137 77 110 243 183 216 153
-13 141 76 153 247 182 259 154
-13 114 89 145 220 195 251 155
-13 146 90 115 252 196 221 156
-13 158 82 123 264 188 229 157
-13 124 83 161 230 189 267 158
-13 170 7 36 276 14 65 159
-13 42 1 169 71 15 275 160
-13 169 1 41 275 15 70 161
-13 37 7 170 66 14 276 162
-13 141 77 129 247 183 235 163
-13 145 84 91 251 190 197 164
-13 91 84 146 197 190 252 165
-13 117 104 177 223 210 283 166
-13 178 105 116 284 211 222 167
-13 138 83 118 244 189 224 168
-13 119 82 139 225 188 245 169
-13 129 77 137 235 183 243 170
-13 153 94 141 259 200 247 171
-13 175 39 122 281 68 228 172
-13 129 76 141 235 182 247 173
-13 111 77 179 217 183 285 174
-13 149 95 144 255 201 250 175
-13 28 27 177 57 56 283 176
-13 22 21 178 51 50 284 177
-13 133 96 171 239 202 277 178
-13 172 97 134 278 203 240 179
-13 165 102 127 271 208 233 180
-13 128 103 164 234 209 270 181
-13 173 102 165 279 208 271 182
-13 164 103 174 270 209 280 183
-13 125 88 152 231 194 258 184
-13 151 87 126 257 193 232 185
-13 122 93 175 228 199 281 186
-13 162 91 140 268 197 246 187
-13 140 91 163 246 197 269 188
-13 154 17 147 260 46 253 189
-13 148 32 155 254 61 261 190
-13 165 79 173 271 185 279 191
-13 174 78 164 280 184 270 192
-13 171 80 112 277 186 218 193
-13 113 81 172 219 187 278 194
-13 142 96 133 248 202 239 195
-13 134 97 143 240 203 249 196
-13 127 99 165 233 205 271 197
-13 164 98 128 270 204 234 198
-13 144 95 176 250 201 282 199
-13 130 80 171 236 186 277 200
-13 172 81 131 278 187 237 201
-13 131 81 166 237 187 272 202
-13 122 39 144 228 68 250 203
-13 166 81 111 272 187 217 204
-13 150 93 174 256 199 280 205
-13 173 95 149 279 201 255 206
-13 135 89 114 241 195 220 207
-13 115 90 136 221 196 242 208
-13 140 3 162 246 10 268 209
-13 163 4 140 269 11 246 210
-13 129 92 132 235 198 238 211
-13 151 98 142 257 204 248 212
-13 143 99 152 249 205 258 213
-13 132 76 129 238 182 235 214
-13 152 34 125 258 63 231 215
-13 126 44 151 232 73 257 216
-13 176 122 144 282 228 250 217
-13 147 87 120 253 193 226 218
-13 121 88 148 227 194 254 219
-13 179 77 141 285 183 247 220
-13 174 103 150 280 209 256 221
-13 149 102 173 255 208 279 222
-13 144 38 149 250 67 255 223
-13 137 92 129 243 198 235 224
-13 175 93 150 281 199 256 225
-13 157 104 158 263 210 264 226
-13 161 105 160 267 211 266 227
-13 153 76 176 259 182 282 228
-13 157 29 156 263 58 262 229
-13 159 20 160 265 49 266 230
-13 179 94 166 285 200 272 231
-13 141 94 179 247 200 285 232
-13 156 28 177 262 57 283 233
-13 178 21 159 284 50 265 234
-13 166 94 131 272 200 237 235
-13 156 104 157 262 210 263 236
-13 160 105 159 266 211 265 237
-13 166 111 179 272 217 285 238
-13 171 96 130 277 202 236 239
-13 131 97 172 237 203 278 240
-13 176 95 153 282 201 259 241
-13 177 104 156 283 210 262 242
-13 159 105 178 265 211 284 243
-13 150 40 175 256 69 281 244
-13 168 3 24 274 10 53 245
-13 25 4 167 54 11 273 246
-NPOIN= 286
--3 0 0 0
--3 0 4 1
--0.05 0 0 2
--0.05 0 1 3
-0.05 0 1 4
-0.05 0 0 5
-3 0 0 6
-3 0 4 7
--3 0.3 0 8
--0.05 0.3 0 9
--0.05 0.3 1 10
-0.05 0.3 1 11
-0.05 0.3 0 12
-3 0.3 0 13
-3 0.3 4 14
--3 0.3 4 15
--2.132421637270402 0 0 16
--1.468963107081476 0 0 17
--0.9616001634889799 0 0 18
--0.5736072649935684 0 0 19
--0.2768996154894059 0 0 20
--0.05 0 0.1999999999995579 21
--0.05 0 0.3999999999989749 22
--0.05 0 0.5999999999989468 23
--0.05 0 0.7999999999994734 24
-0.05 0 0.7999999999999998 25
-0.05 0 0.6000000000013869 26
-0.05 0 0.4000000000016644 27
-0.05 0 0.2000000000008322 28
-0.2768996154886466 0 0 29
-0.5736072649914844 0 0 30
-0.9616001634848403 0 0 31
-1.46896310707403 0 0 32
-2.13242163726539 0 0 33
-3 0 0.9999999999976482 34
-3 0 1.999999999994776 35
-3 0 2.999999999997367 36
-2.000000000003705 0 4 37
-1.000000000007407 0 4 38
-1.10227382776884e-11 0 4 39
--0.9999999999925877 0 4 40
--1.999999999996295 0 4 41
--3 0 3.000000000001386 42
--3 0 2.000000000008237 43
--3 0 1.000000000004162 44
--2.132421637270402 0.3 0 45
--1.468963107081476 0.3 0 46
--0.9616001634889799 0.3 0 47
--0.5736072649935684 0.3 0 48
--0.2768996154894059 0.3 0 49
--0.05 0.3 0.1999999999995579 50
--0.05 0.3 0.3999999999989749 51
--0.05 0.3 0.5999999999989468 52
--0.05 0.3 0.7999999999994734 53
-0.05 0.3 0.7999999999999998 54
-0.05 0.3 0.6000000000013869 55
-0.05 0.3 0.4000000000016644 56
-0.05 0.3 0.2000000000008322 57
-0.2768996154886466 0.3 0 58
-0.5736072649914844 0.3 0 59
-0.9616001634848403 0.3 0 60
-1.46896310707403 0.3 0 61
-2.13242163726539 0.3 0 62
-3 0.3 0.9999999999976482 63
-3 0.3 1.999999999994776 64
-3 0.3 2.999999999997367 65
-2.000000000003705 0.3 4 66
-1.000000000007407 0.3 4 67
-1.10227382776884e-11 0.3 4 68
--0.9999999999925877 0.3 4 69
--1.999999999996295 0.3 4 70
--3 0.3 3.000000000001386 71
--3 0.3 2.000000000008237 72
--3 0.3 1.000000000004162 73
-0.9825948741531498 0 0.9203063592825887 74
--0.9825948741537733 0 0.9203063592817843 75
-0.03134793409687708 0 2.55397966579226 76
--0.0009606257234580401 0 1.748697432502003 77
--1.129679824287611 0 2.119543773237748 78
-1.132029953157837 0 2.122440212022948 79
--0.5196051848669313 0 1.412361811251357 80
-0.5497855166715109 0 1.395413135418834 81
-0.5374226884505656 0 0.493812701154998 82
--0.5374226884502991 0 0.4938127011534965 83
--0.0001601042872495425 0 1.423899928231195 84
-0.465281877129912 0 0.8722244593273728 85
--0.4652818771308316 0 0.8722244593264402 86
--1.779160986901294 0 0.8965036540400221 87
-1.779160986895464 0 0.8965036540386054 88
--0.3024549228140815 0 1.2718106380794 89
-0.3084909891748027 0 1.26842090291295 90
--1.906003421713626e-05 0 1.200234358426896 91
--0.5618007820408263 0 2.043746239937465 92
--0.8083224307437241 0 2.889383374999068 93
-0.5647434910278286 0 2.01494617901649 94
-0.8221850434196895 0 2.852649226946881 95
--1.158518924678652 0 1.551501353485399 96
-1.158988950451789 0 1.552080641242281 97
--2.21678168145761 0 1.838237906171512 98
-2.216781681455013 0 1.83823790616389 99
-0.967097151716251 0 0.4607420247048584 100
--0.9670971517153459 0 0.4607420247046419 101
-1.854114598533743 0 3.012715418354706 102
--1.854114598532094 0 3.012715418358399 103
-0.3467727762006756 0 0.3138478024891123 104
--0.3467727761998039 0 0.3138478024875392 105
-0.2714569979187768 0 0.7206820098998908 106
--0.2714569979194104 0 0.7206820098987166 107
--0.2889797296894188 0 0.9267545678931778 108
-0.2889797296888021 0 0.9267545678937171 109
--0.2096255493199925 0 1.496037590846734 110
-0.2517633613169607 0 1.518247420292257 111
--0.6660432832766596 0 1.081962603010036 112
-0.6589236055220503 0 1.065642443794388 113
--0.2065827934826303 0 1.069425960577202 114
-0.2065827934823721 0 1.069425960577464 115
--0.2339028924130573 0 0.4854032749601151 116
-0.2339028924126051 0 0.4854032749623373 117
--0.6934692988371788 0 0.7488579429535888 118
-0.6931604137473489 0 0.7481498977313378 119
--1.31236288406761 0 0.6646874262097189 120
-1.312362884063586 0 0.6646874262090433 121
--0.1380533872983328 0 3.181603062552175 122
-0.7419949146702542 0 0.2620513753100355 123
--0.7419949146691938 0 0.2620513753103896 124
-2.375341278589752 0 0.5856470294858179 125
--2.375341278594772 0 0.5856470294875045 126
-2.370934994068257 0 2.530901175131019 127
--2.370934994068034 0 2.530901175137551 128
--0.1790781052807056 0 2.118264311918558 129
--0.7921348971844293 0 1.723545051111688 130
-0.7983255105839553 0 1.699241333964839 131
--0.4642644325923871 0 2.484420071406212 132
--1.296959501136076 0 1.140605243476817 133
-1.297037838762715 0 1.140701791435802 134
--0.4081579652100921 0 1.105756673356268 135
-0.4130074186115749 0 1.099646911654121 136
--0.3772008574027238 0 1.757108739594634 137
--0.4919077155844299 0 0.7088942783330604 138
-0.4918304943116507 0 0.7087172670283998 139
--3.812006875457408e-06 0 1.075683673435016 140
-0.1951707213103545 0 2.080383973855081 141
--1.661418383658756 0 1.556854534039652 142
-1.661832453980385 0 1.557364858964508 143
-0.5290562426421479 0 3.38598360973986 144
--0.1371705261972805 0 1.258416746755928 145
-0.1451397844830034 0 1.261553429135801 146
--1.670022720633292 0 0.3934843812824604 147
-1.670022720624052 0 0.3934843812811255 148
-1.262577532593635 0 3.36452247006787 149
--1.26257753259416 0 3.364522470071912 150
--2.259570044434444 0 1.141342455190163 151
-2.259570044423067 0 1.141342455181824 152
-0.4855341639785172 0 2.466426775981777 153
--1.276009205397341 0 0.3037827664393642 154
-1.276009205392552 0 0.3037827664390054 155
-0.2135573730685918 0 0.1580206643002382 156
-0.3890522885319399 0 0.1526836842918348 157
-0.5300891290855102 0 0.2792970282796143 158
--0.2135573730679655 0 0.1580206642994352 159
--0.3890522885318832 0 0.1526836842909433 160
--0.5300891290842963 0 0.2792970282778868 161
--0.07875523834420067 0 1.120752147839008 162
-0.0803399411848566 0 1.121379484315036 163
--1.773494387528787 0 2.251338641411685 164
-1.773729438481018 0 2.251628332197096 165
-0.5131609952661074 0 1.722883911813639 166
-0.156248328034906 0 0.90240893405301 167
--0.1562483280352914 0 0.9024089340525773 168
--2.398406843342383 0 3.39840684334441 169
-2.398406843344079 0 3.398406843341552 170
--0.9026427775494201 0 1.305047070269513 171
-0.9076093826908616 0 1.295564284189789 172
-1.368927313237185 0 2.7207911319179 173
--1.365637754737275 0 2.727500735615763 174
--0.6417906701235564 0 3.48710178152463 175
-0.3460139993677798 0 2.888128468202591 176
-0.1788466083363745 0 0.3114543483508369 177
--0.1788466083361653 0 0.3114543483491244 178
-0.2711768521854932 0 1.797395744097217 179
-0.9825948741531498 0.3 0.9203063592825887 180
--0.9825948741537733 0.3 0.9203063592817843 181
-0.03134793409687708 0.3 2.55397966579226 182
--0.0009606257234580401 0.3 1.748697432502003 183
--1.129679824287611 0.3 2.119543773237748 184
-1.132029953157837 0.3 2.122440212022948 185
--0.5196051848669313 0.3 1.412361811251357 186
-0.5497855166715109 0.3 1.395413135418834 187
-0.5374226884505656 0.3 0.493812701154998 188
--0.5374226884502991 0.3 0.4938127011534965 189
--0.0001601042872495425 0.3 1.423899928231195 190
-0.465281877129912 0.3 0.8722244593273728 191
--0.4652818771308316 0.3 0.8722244593264402 192
--1.779160986901294 0.3 0.8965036540400221 193
-1.779160986895464 0.3 0.8965036540386054 194
--0.3024549228140815 0.3 1.2718106380794 195
-0.3084909891748027 0.3 1.26842090291295 196
--1.906003421713626e-05 0.3 1.200234358426896 197
--0.5618007820408263 0.3 2.043746239937465 198
--0.8083224307437241 0.3 2.889383374999068 199
-0.5647434910278286 0.3 2.01494617901649 200
-0.8221850434196895 0.3 2.852649226946881 201
--1.158518924678652 0.3 1.551501353485399 202
-1.158988950451789 0.3 1.552080641242281 203
--2.21678168145761 0.3 1.838237906171512 204
-2.216781681455013 0.3 1.83823790616389 205
-0.967097151716251 0.3 0.4607420247048584 206
--0.9670971517153459 0.3 0.4607420247046419 207
-1.854114598533743 0.3 3.012715418354706 208
--1.854114598532094 0.3 3.012715418358399 209
-0.3467727762006756 0.3 0.3138478024891123 210
--0.3467727761998039 0.3 0.3138478024875392 211
-0.2714569979187768 0.3 0.7206820098998908 212
--0.2714569979194104 0.3 0.7206820098987166 213
--0.2889797296894188 0.3 0.9267545678931778 214
-0.2889797296888021 0.3 0.9267545678937171 215
--0.2096255493199925 0.3 1.496037590846734 216
-0.2517633613169607 0.3 1.518247420292257 217
--0.6660432832766596 0.3 1.081962603010036 218
-0.6589236055220503 0.3 1.065642443794388 219
--0.2065827934826303 0.3 1.069425960577202 220
-0.2065827934823721 0.3 1.069425960577464 221
--0.2339028924130573 0.3 0.4854032749601151 222
-0.2339028924126051 0.3 0.4854032749623373 223
--0.6934692988371788 0.3 0.7488579429535888 224
-0.6931604137473489 0.3 0.7481498977313378 225
--1.31236288406761 0.3 0.6646874262097189 226
-1.312362884063586 0.3 0.6646874262090433 227
--0.1380533872983328 0.3 3.181603062552175 228
-0.7419949146702542 0.3 0.2620513753100355 229
--0.7419949146691938 0.3 0.2620513753103896 230
-2.375341278589752 0.3 0.5856470294858179 231
--2.375341278594772 0.3 0.5856470294875045 232
-2.370934994068257 0.3 2.530901175131019 233
--2.370934994068034 0.3 2.530901175137551 234
--0.1790781052807056 0.3 2.118264311918558 235
--0.7921348971844293 0.3 1.723545051111688 236
-0.7983255105839553 0.3 1.699241333964839 237
--0.4642644325923871 0.3 2.484420071406212 238
--1.296959501136076 0.3 1.140605243476817 239
-1.297037838762715 0.3 1.140701791435802 240
--0.4081579652100921 0.3 1.105756673356268 241
-0.4130074186115749 0.3 1.099646911654121 242
--0.3772008574027238 0.3 1.757108739594634 243
--0.4919077155844299 0.3 0.7088942783330604 244
-0.4918304943116507 0.3 0.7087172670283998 245
--3.812006875457408e-06 0.3 1.075683673435016 246
-0.1951707213103545 0.3 2.080383973855081 247
--1.661418383658756 0.3 1.556854534039652 248
-1.661832453980385 0.3 1.557364858964508 249
-0.5290562426421479 0.3 3.38598360973986 250
--0.1371705261972805 0.3 1.258416746755928 251
-0.1451397844830034 0.3 1.261553429135801 252
--1.670022720633292 0.3 0.3934843812824604 253
-1.670022720624052 0.3 0.3934843812811255 254
-1.262577532593635 0.3 3.36452247006787 255
--1.26257753259416 0.3 3.364522470071912 256
--2.259570044434444 0.3 1.141342455190163 257
-2.259570044423067 0.3 1.141342455181824 258
-0.4855341639785172 0.3 2.466426775981777 259
--1.276009205397341 0.3 0.3037827664393642 260
-1.276009205392552 0.3 0.3037827664390054 261
-0.2135573730685918 0.3 0.1580206643002382 262
-0.3890522885319399 0.3 0.1526836842918348 263
-0.5300891290855102 0.3 0.2792970282796143 264
--0.2135573730679655 0.3 0.1580206642994352 265
--0.3890522885318832 0.3 0.1526836842909433 266
--0.5300891290842963 0.3 0.2792970282778868 267
--0.07875523834420067 0.3 1.120752147839008 268
-0.0803399411848566 0.3 1.121379484315036 269
--1.773494387528787 0.3 2.251338641411685 270
-1.773729438481018 0.3 2.251628332197096 271
-0.5131609952661074 0.3 1.722883911813639 272
-0.156248328034906 0.3 0.90240893405301 273
--0.1562483280352914 0.3 0.9024089340525773 274
--2.398406843342383 0.3 3.39840684334441 275
-2.398406843344079 0.3 3.398406843341552 276
--0.9026427775494201 0.3 1.305047070269513 277
-0.9076093826908616 0.3 1.295564284189789 278
-1.368927313237185 0.3 2.7207911319179 279
--1.365637754737275 0.3 2.727500735615763 280
--0.6417906701235564 0.3 3.48710178152463 281
-0.3460139993677798 0.3 2.888128468202591 282
-0.1788466083363745 0.3 0.3114543483508369 283
--0.1788466083361653 0.3 0.3114543483491244 284
-0.2711768521854932 0.3 1.797395744097217 285
-NMARK= 6
-MARKER_TAG= inlet
-MARKER_ELEMS= 4
-9 1 42 71 15
-9 42 43 72 71
-9 43 44 73 72
-9 44 0 8 73
-MARKER_TAG= outlet
-MARKER_ELEMS= 4
-9 6 34 63 13
-9 34 35 64 63
-9 35 36 65 64
-9 36 7 14 65
-MARKER_TAG= lower_wall
-MARKER_ELEMS= 12
-9 0 16 45 8
-9 16 17 46 45
-9 17 18 47 46
-9 18 19 48 47
-9 19 20 49 48
-9 20 2 9 49
-9 5 29 58 12
-9 29 30 59 58
-9 30 31 60 59
-9 31 32 61 60
-9 32 33 62 61
-9 33 6 13 62
-MARKER_TAG= upper_wall
-MARKER_ELEMS= 6
-9 7 37 66 14
-9 37 38 67 66
-9 38 39 68 67
-9 39 40 69 68
-9 40 41 70 69
-9 41 1 15 70
-MARKER_TAG= wetSurface0
-MARKER_ELEMS= 11
-9 2 21 50 9
-9 21 22 51 50
-9 22 23 52 51
-9 23 24 53 52
-9 24 3 10 53
-9 3 4 11 10
-9 4 25 54 11
-9 25 26 55 54
-9 26 27 56 55
-9 27 28 57 56
-9 28 5 12 57
-MARKER_TAG= symmetry
-MARKER_ELEMS= 494
-5 109 167 106
-5 108 107 168
-5 82 100 119
-5 83 118 101
-5 106 167 25
-5 107 24 168
-5 77 110 84
-5 77 84 111
-5 78 92 132
-5 82 106 117
-5 83 116 107
-5 80 110 137
-5 78 142 96
-5 79 97 143
-5 82 123 100
-5 83 101 124
-5 25 26 106
-5 23 24 107
-5 4 167 115
-5 3 114 168
-5 35 99 152
-5 43 151 98
-5 79 153 94
-5 76 122 132
-5 86 112 118
-5 85 119 113
-5 74 119 100
-5 75 101 118
-5 78 132 93
-5 86 107 108
-5 85 109 106
-5 80 135 89
-5 81 90 136
-5 82 139 106
-5 83 107 138
-5 80 137 130
-5 82 117 104
-5 83 105 116
-5 75 112 171
-5 74 172 113
-5 79 95 153
-5 75 120 101
-5 74 100 121
-5 88 148 125
-5 87 126 147
-5 33 125 148
-5 16 147 126
-5 78 164 142
-5 79 143 165
-5 4 115 163
-5 3 162 114
-5 34 35 152
-5 43 44 151
-5 85 113 136
-5 86 135 112
-5 31 100 123
-5 18 124 101
-5 23 107 116
-5 26 117 106
-5 80 112 135
-5 81 136 113
-5 84 110 145
-5 84 146 111
-5 75 171 133
-5 74 134 172
-5 93 132 122
-5 100 155 121
-5 101 120 154
-5 18 19 124
-5 30 31 123
-5 114 162 145
-5 115 146 163
-5 32 33 148
-5 16 17 147
-5 109 136 115
-5 108 114 135
-5 6 125 33
-5 0 16 126
-5 37 149 102
-5 41 103 150
-5 78 93 174
-5 79 173 95
-5 89 145 110
-5 90 111 146
-5 85 136 109
-5 86 108 135
-5 31 32 155
-5 17 18 154
-5 109 115 167
-5 108 168 114
-5 5 156 28
-5 2 21 159
-5 76 176 122
-5 5 29 156
-5 2 159 20
-5 19 20 160
-5 29 30 157
-5 22 23 116
-5 26 27 117
-5 88 143 134
-5 87 133 142
-5 0 126 44
-5 6 34 125
-5 75 118 112
-5 74 113 119
-5 80 89 110
-5 81 111 90
-5 86 138 107
-5 85 106 139
-5 31 155 100
-5 18 101 154
-5 37 102 170
-5 41 169 103
-5 121 155 148
-5 120 147 154
-5 86 118 138
-5 85 139 119
-5 91 163 146
-5 91 145 162
-5 78 130 92
-5 79 94 131
-5 88 134 121
-5 87 120 133
-5 92 130 137
-5 37 38 149
-5 40 41 150
-5 43 98 128
-5 35 127 99
-5 78 96 130
-5 79 131 97
-5 102 127 170
-5 103 169 128
-5 98 142 164
-5 99 165 143
-5 35 36 127
-5 42 43 128
-5 82 104 158
-5 83 161 105
-5 30 123 158
-5 19 161 124
-5 42 128 169
-5 36 170 127
-5 3 4 140
-5 39 40 175
-5 22 116 178
-5 27 177 117
-5 88 152 143
-5 87 142 151
-5 75 133 120
-5 74 121 134
-5 30 158 157
-5 19 160 161
-5 38 39 144
-5 77 137 110
-5 76 141 153
-5 89 114 145
-5 90 146 115
-5 82 158 123
-5 83 124 161
-5 7 170 36
-5 1 42 169
-5 1 169 41
-5 7 37 170
-5 77 141 129
-5 84 145 91
-5 84 91 146
-5 104 117 177
-5 105 178 116
-5 83 138 118
-5 82 119 139
-5 77 129 137
-5 94 153 141
-5 39 175 122
-5 76 129 141
-5 77 111 179
-5 95 149 144
-5 27 28 177
-5 21 22 178
-5 96 133 171
-5 97 172 134
-5 102 165 127
-5 103 128 164
-5 102 173 165
-5 103 164 174
-5 88 125 152
-5 87 151 126
-5 93 122 175
-5 91 162 140
-5 91 140 163
-5 17 154 147
-5 32 148 155
-5 79 165 173
-5 78 174 164
-5 80 171 112
-5 81 113 172
-5 96 142 133
-5 97 134 143
-5 99 127 165
-5 98 164 128
-5 95 144 176
-5 80 130 171
-5 81 172 131
-5 81 131 166
-5 39 122 144
-5 81 166 111
-5 93 150 174
-5 95 173 149
-5 89 135 114
-5 90 115 136
-5 3 140 162
-5 4 163 140
-5 92 129 132
-5 98 151 142
-5 99 143 152
-5 76 132 129
-5 34 152 125
-5 44 126 151
-5 122 176 144
-5 87 147 120
-5 88 121 148
-5 77 179 141
-5 103 174 150
-5 102 149 173
-5 38 144 149
-5 92 137 129
-5 93 175 150
-5 104 157 158
-5 105 161 160
-5 76 153 176
-5 29 157 156
-5 20 159 160
-5 94 179 166
-5 94 141 179
-5 28 156 177
-5 21 178 159
-5 94 166 131
-5 104 156 157
-5 105 160 159
-5 111 166 179
-5 96 171 130
-5 97 131 172
-5 95 176 153
-5 104 177 156
-5 105 159 178
-5 40 150 175
-5 3 168 24
-5 4 25 167
-5 215 273 212
-5 214 213 274
-5 188 206 225
-5 189 224 207
-5 212 273 54
-5 213 53 274
-5 183 216 190
-5 183 190 217
-5 184 198 238
-5 188 212 223
-5 189 222 213
-5 186 216 243
-5 184 248 202
-5 185 203 249
-5 188 229 206
-5 189 207 230
-5 54 55 212
-5 52 53 213
-5 11 273 221
-5 10 220 274
-5 64 205 258
-5 72 257 204
-5 185 259 200
-5 182 228 238
-5 192 218 224
-5 191 225 219
-5 180 225 206
-5 181 207 224
-5 184 238 199
-5 192 213 214
-5 191 215 212
-5 186 241 195
-5 187 196 242
-5 188 245 212
-5 189 213 244
-5 186 243 236
-5 188 223 210
-5 189 211 222
-5 181 218 277
-5 180 278 219
-5 185 201 259
-5 181 226 207
-5 180 206 227
-5 194 254 231
-5 193 232 253
-5 62 231 254
-5 45 253 232
-5 184 270 248
-5 185 249 271
-5 11 221 269
-5 10 268 220
-5 63 64 258
-5 72 73 257
-5 191 219 242
-5 192 241 218
-5 60 206 229
-5 47 230 207
-5 52 213 222
-5 55 223 212
-5 186 218 241
-5 187 242 219
-5 190 216 251
-5 190 252 217
-5 181 277 239
-5 180 240 278
-5 199 238 228
-5 206 261 227
-5 207 226 260
-5 47 48 230
-5 59 60 229
-5 220 268 251
-5 221 252 269
-5 61 62 254
-5 45 46 253
-5 215 242 221
-5 214 220 241
-5 13 231 62
-5 8 45 232
-5 66 255 208
-5 70 209 256
-5 184 199 280
-5 185 279 201
-5 195 251 216
-5 196 217 252
-5 191 242 215
-5 192 214 241
-5 60 61 261
-5 46 47 260
-5 215 221 273
-5 214 274 220
-5 12 262 57
-5 9 50 265
-5 182 282 228
-5 12 58 262
-5 9 265 49
-5 48 49 266
-5 58 59 263
-5 51 52 222
-5 55 56 223
-5 194 249 240
-5 193 239 248
-5 8 232 73
-5 13 63 231
-5 181 224 218
-5 180 219 225
-5 186 195 216
-5 187 217 196
-5 192 244 213
-5 191 212 245
-5 60 261 206
-5 47 207 260
-5 66 208 276
-5 70 275 209
-5 227 261 254
-5 226 253 260
-5 192 224 244
-5 191 245 225
-5 197 269 252
-5 197 251 268
-5 184 236 198
-5 185 200 237
-5 194 240 227
-5 193 226 239
-5 198 236 243
-5 66 67 255
-5 69 70 256
-5 72 204 234
-5 64 233 205
-5 184 202 236
-5 185 237 203
-5 208 233 276
-5 209 275 234
-5 204 248 270
-5 205 271 249
-5 64 65 233
-5 71 72 234
-5 188 210 264
-5 189 267 211
-5 59 229 264
-5 48 267 230
-5 71 234 275
-5 65 276 233
-5 10 11 246
-5 68 69 281
-5 51 222 284
-5 56 283 223
-5 194 258 249
-5 193 248 257
-5 181 239 226
-5 180 227 240
-5 59 264 263
-5 48 266 267
-5 67 68 250
-5 183 243 216
-5 182 247 259
-5 195 220 251
-5 196 252 221
-5 188 264 229
-5 189 230 267
-5 14 276 65
-5 15 71 275
-5 15 275 70
-5 14 66 276
-5 183 247 235
-5 190 251 197
-5 190 197 252
-5 210 223 283
-5 211 284 222
-5 189 244 224
-5 188 225 245
-5 183 235 243
-5 200 259 247
-5 68 281 228
-5 182 235 247
-5 183 217 285
-5 201 255 250
-5 56 57 283
-5 50 51 284
-5 202 239 277
-5 203 278 240
-5 208 271 233
-5 209 234 270
-5 208 279 271
-5 209 270 280
-5 194 231 258
-5 193 257 232
-5 199 228 281
-5 197 268 246
-5 197 246 269
-5 46 260 253
-5 61 254 261
-5 185 271 279
-5 184 280 270
-5 186 277 218
-5 187 219 278
-5 202 248 239
-5 203 240 249
-5 205 233 271
-5 204 270 234
-5 201 250 282
-5 186 236 277
-5 187 278 237
-5 187 237 272
-5 68 228 250
-5 187 272 217
-5 199 256 280
-5 201 279 255
-5 195 241 220
-5 196 221 242
-5 10 246 268
-5 11 269 246
-5 198 235 238
-5 204 257 248
-5 205 249 258
-5 182 238 235
-5 63 258 231
-5 73 232 257
-5 228 282 250
-5 193 253 226
-5 194 227 254
-5 183 285 247
-5 209 280 256
-5 208 255 279
-5 67 250 255
-5 198 243 235
-5 199 281 256
-5 210 263 264
-5 211 267 266
-5 182 259 282
-5 58 263 262
-5 49 265 266
-5 200 285 272
-5 200 247 285
-5 57 262 283
-5 50 284 265
-5 200 272 237
-5 210 262 263
-5 211 266 265
-5 217 272 285
-5 202 277 236
-5 203 237 278
-5 201 282 259
-5 210 283 262
-5 211 265 284
-5 69 256 281
-5 10 274 53
-5 11 54 273
diff --git a/FSI/flap_perp/SU2-CalculiX/Fluid/initial_flow_00000.dat b/FSI/flap_perp/SU2-CalculiX/Fluid/initial_flow_00000.dat
deleted file mode 100644
index 75b81d6e8..000000000
--- a/FSI/flap_perp/SU2-CalculiX/Fluid/initial_flow_00000.dat
+++ /dev/null
@@ -1,287 +0,0 @@
-"PointID" "x" "y" "z" "Conservative_1" "Conservative_2" "Conservative_3" "Conservative_4" "Conservative_5" "Pressure" "Temperature" "Pressure_Coefficient" "Mach"
-0 -3.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 1.223524375381033e+00 9.058620354054316e+00 1.127783801353701e-12 1.338384131258720e-02 2.534184290896417e+05 1.013539581259181e+05 2.885748197400928e+02 7.609381739970193e+00 2.174061599719721e-02
-1 -3.000000000000000e+00 0.000000000000000e+00 4.000000000000000e+00 1.223353576670957e+00 1.150979252414000e+01 2.670323747920718e-10 -7.329764325498413e-02 2.533910220309653e+05 1.013347502013321e+05 2.885604127547623e+02 4.900606590338714e+00 2.762848587080241e-02
-2 -5.000000000000000e-02 0.000000000000000e+00 0.000000000000000e+00 1.225803294644949e+00 7.675211520757778e-01 -1.347551402221548e-09 6.923012631251900e-01 2.534194390878943e+05 1.013676013217483e+05 2.880770962834463e+02 9.533397510687241e+00 2.478202541928246e-03
-3 -5.000000000000000e-02 0.000000000000000e+00 1.000000000000000e+00 1.224809896818344e+00 4.063379537727067e+00 -2.352013547902491e-09 8.212680327353613e+00 2.532468038026821e+05 1.012850117736834e+05 2.880758429009668e+02 -2.113697125449678e+00 2.198685535002810e-02
-4 5.000000000000000e-02 0.000000000000000e+00 1.000000000000000e+00 1.218986969178522e+00 1.009211346926040e+00 4.165581935409654e-10 1.712477039923902e+00 2.519742784922424e+05 1.007890631397367e+05 2.880346200797898e+02 -7.205427446950709e+01 4.792784933690381e-03
-5 5.000000000000000e-02 0.000000000000000e+00 0.000000000000000e+00 1.224621743324402e+00 -4.208240416525106e-01 -5.277652756245907e-10 3.523819394731408e-01 2.530267012807458e+05 1.012106313108356e+05 2.879085173278013e+02 -1.260311509863863e+01 1.317640467763000e-03
-6 3.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 1.226068208631307e+00 2.914301117777959e+00 -6.615455506471728e-10 -1.493574772875098e-01 2.534174941540622e+05 1.013656085939366e+05 2.880091901498756e+02 9.252375396500854e+00 6.995799801248152e-03
-7 3.000000000000000e+00 0.000000000000000e+00 4.000000000000000e+00 1.224661336904488e+00 1.559339634888616e+01 8.728695135427217e-11 9.409557047092554e-02 2.532988070667369e+05 1.012798117888197e+05 2.880959968556343e+02 -2.847018922626213e+00 3.742098030835350e-02
-8 -3.000000000000000e+00 3.000000000000000e-01 0.000000000000000e+00 1.223524375382719e+00 9.058620354033044e+00 3.743606477458560e-10 1.338384193454472e-02 2.534184290901837e+05 1.013539581261350e+05 2.885748197403127e+02 7.609381770551583e+00 2.174061599711013e-02
-9 -5.000000000000000e-02 3.000000000000000e-01 0.000000000000000e+00 1.225803294643098e+00 7.675211520597993e-01 4.323880179123028e-09 6.923012639629184e-01 2.534194390879520e+05 1.013676013217712e+05 2.880770962839462e+02 9.533397513913247e+00 2.478202543246673e-03
-10 -5.000000000000000e-02 3.000000000000000e-01 1.000000000000000e+00 1.224809896818370e+00 4.063379540713457e+00 2.531020316551292e-09 8.212680331233020e+00 2.532468038029890e+05 1.012850117737918e+05 2.880758429012690e+02 -2.113697110161035e+00 2.198685536153736e-02
-11 5.000000000000000e-02 3.000000000000000e-01 1.000000000000000e+00 1.218986969174661e+00 1.009211350817868e+00 6.282085911961919e-09 1.712477038687238e+00 2.519742784915061e+05 1.007890631394416e+05 2.880346200798587e+02 -7.205427451113120e+01 4.792784935900476e-03
-12 5.000000000000000e-02 3.000000000000000e-01 0.000000000000000e+00 1.224621743321508e+00 -4.208240401609663e-01 5.872201961929463e-09 3.523819410281110e-01 2.530267012804440e+05 1.012106313107148e+05 2.879085173281385e+02 -1.260311511566136e+01 1.317640467416610e-03
-13 3.000000000000000e+00 3.000000000000000e-01 0.000000000000000e+00 1.226068208631314e+00 2.914301120291241e+00 2.025432680890708e-10 -1.493574789458612e-01 2.534174941547271e+05 1.013656085942001e+05 2.880091901506225e+02 9.252375433659440e+00 6.995799807459870e-03
-14 3.000000000000000e+00 3.000000000000000e-01 4.000000000000000e+00 1.224661336903399e+00 1.559339634841785e+01 -5.344484761829765e-10 9.409557163510293e-02 2.532988070667208e+05 1.012798117888155e+05 2.880959968558788e+02 -2.847018923209028e+00 3.742098030726396e-02
-15 -3.000000000000000e+00 3.000000000000000e-01 4.000000000000000e+00 1.223353576673722e+00 1.150979252446699e+01 -2.696805587802572e-10 -7.329764383487017e-02 2.533910220315952e+05 1.013347502015829e+05 2.885604127548241e+02 4.900606625703705e+00 2.762848587153076e-02
-16 -2.132421637270402e+00 0.000000000000000e+00 0.000000000000000e+00 1.223559777412596e+00 8.423582985892914e+00 -2.688632944893400e-09 4.253073865891412e-02 2.534033932871912e+05 1.013497586074829e+05 2.885545137057949e+02 7.017149553357462e+00 2.021689340336028e-02
-17 -1.468963107081476e+00 0.000000000000000e+00 0.000000000000000e+00 1.223888239938552e+00 7.394203154147625e+00 -4.505391599766793e-09 7.779523224242227e-02 2.534235751566568e+05 1.013604945584886e+05 2.885076308238803e+02 8.531174515383773e+00 1.774378043924111e-02
-18 -9.616001634889799e-01 0.000000000000000e+00 0.000000000000000e+00 1.224115120808597e+00 6.015982772684704e+00 -6.213405427902371e-09 1.385057021529970e-01 2.533735241644725e+05 1.013434933541717e+05 2.884057755841829e+02 6.133599516526460e+00 1.443938078202991e-02
-19 -5.736072649935684e-01 0.000000000000000e+00 0.000000000000000e+00 1.225030865722313e+00 4.110818605738627e+00 -4.728025217910878e-09 1.786019888257759e-01 2.534237524101067e+05 1.013667368331537e+05 2.882562815925546e+02 9.411484015464156e+00 9.868531993044610e-03
-20 -2.768996154894059e-01 0.000000000000000e+00 0.000000000000000e+00 1.225373809981959e+00 2.397085469972577e+00 -2.358933933075557e-09 -2.630672160525858e-02 2.533882113534618e+05 1.013543465891048e+05 2.881403833293747e+02 7.664164307544252e+00 5.748971648961970e-03
-21 -5.000000000000000e-02 0.000000000000000e+00 1.999999999995579e-01 1.226101907163173e+00 -1.136701241256693e-02 -2.855123522343303e-09 2.203637226744394e+00 2.534669697015724e+05 1.013859957529587e+05 2.880591986829139e+02 1.212745070634158e+01 5.282379403907115e-03
-22 -5.000000000000000e-02 0.000000000000000e+00 3.999999999989749e-01 1.225609017524917e+00 7.464508324819960e-02 -4.021098641938437e-09 3.748001634586076e+00 2.533695204327533e+05 1.013455149314654e+05 2.880599833821572e+02 6.418690095253264e+00 8.989667453850707e-03
-23 -5.000000000000000e-02 0.000000000000000e+00 5.999999999989468e-01 1.225316773252931e+00 2.568358038225779e-02 -4.584289654704001e-09 5.217976863324829e+00 2.533330531118005e+05 1.013287770156380e+05 2.880811006965407e+02 4.058245048377230e+00 1.251563249931680e-02
-24 -5.000000000000000e-02 0.000000000000000e+00 7.999999999994734e-01 1.226479916750107e+00 -1.757659191497987e-01 -4.238159593558133e-09 7.501598791653409e+00 2.535877139171488e+05 1.014259040258786e+05 2.880837697997841e+02 1.775546832303289e+01 1.798060618609571e-02
-25 5.000000000000000e-02 0.000000000000000e+00 7.999999999999998e-01 1.225447457313241e+00 -2.570019151184382e-02 -4.010782061553429e-10 3.139984552928898e+00 2.532512231066456e+05 1.012988800078544e+05 2.879653900487749e+02 -1.579455853272378e-01 7.532313213641914e-03
-26 5.000000000000000e-02 0.000000000000000e+00 6.000000000013869e-01 1.224381443808574e+00 -1.272503914398862e-01 -3.573809820347347e-09 2.365666620264628e+00 2.530011438976584e+05 1.011995407579719e+05 2.879334679213860e+02 -1.416714737387195e+01 5.688126867773701e-03
-27 5.000000000000000e-02 0.000000000000000e+00 4.000000000016644e-01 1.224606997489544e+00 -4.624922354837979e-02 -4.365242682586655e-09 1.884188380125942e+00 2.530317389391052e+05 1.012121154213803e+05 2.879162059360879e+02 -1.239382014097611e+01 4.524561301785870e-03
-28 5.000000000000000e-02 0.000000000000000e+00 2.000000000008322e-01 1.224745261723637e+00 -2.426723811289560e-02 -3.380425304526855e-09 1.121915474284008e+00 2.530540348804452e+05 1.012214083121532e+05 2.879101347588213e+02 -1.108330106427631e+01 2.693634218431275e-03
-29 2.768996154886466e-01 0.000000000000000e+00 0.000000000000000e+00 1.224524582984839e+00 -1.162310223093104e+00 -3.583991087811243e-09 -2.403450522491605e-04 2.530101238833723e+05 1.012038289019824e+05 2.879120095445330e+02 -1.356241686892621e+01 2.790460139032174e-03
-30 5.736072649914844e-01 0.000000000000000e+00 0.000000000000000e+00 1.224474943694568e+00 -1.849797037658345e+00 -1.185703942600551e-08 9.007803341198488e-02 2.530096378454171e+05 1.012032949203934e+05 2.879221621089252e+02 -1.363772099937585e+01 4.446334171892981e-03
-31 9.616001634848403e-01 0.000000000000000e+00 0.000000000000000e+00 1.224694585314730e+00 -2.224119199069102e+00 -1.511224165582265e-08 1.173411614659554e-02 2.530729095033230e+05 1.012283559519338e+05 2.879418105456791e+02 -1.010351827191990e+01 5.338694808170789e-03
-32 1.468963107074030e+00 0.000000000000000e+00 0.000000000000000e+00 1.224816070201709e+00 -1.389166357741825e+00 -1.338299237514109e-08 -1.148821354473221e-01 2.531126286988948e+05 1.012447342105211e+05 2.879598336553714e+02 -7.793793467627203e+00 3.345404271735094e-03
-33 2.132421637265390e+00 0.000000000000000e+00 0.000000000000000e+00 1.224978011407637e+00 4.749880421737367e-01 -7.186019989761165e-09 -1.494560779311591e-01 2.531679594489898e+05 1.012671432971126e+05 2.879854929749162e+02 -4.633578181837467e+00 1.194868955287496e-03
-34 3.000000000000000e+00 0.000000000000000e+00 9.999999999976482e-01 1.225527508403437e+00 6.349564924001267e+00 1.698857687164797e-09 -1.594346868312567e+00 2.533394885802342e+05 1.013288010698510e+05 2.880316321876389e+02 4.061637265689505e+00 1.570104624579958e-02
-35 3.000000000000000e+00 0.000000000000000e+00 1.999999999994776e+00 1.225179076907097e+00 1.106719397198315e+01 2.107158604168812e-09 -1.451075679006922e+00 2.533246730599813e+05 1.013095312333448e+05 2.880587552195512e+02 1.344131059761035e+00 2.677625609360059e-02
-36 3.000000000000000e+00 0.000000000000000e+00 2.999999999997367e+00 1.224756585601096e+00 1.435687140502741e+01 1.531771164681839e-09 -4.455427454440229e-01 2.532812788805461e+05 1.012788202428915e+05 2.880707714889218e+02 -2.986850530042803e+00 3.446835934473102e-02
-37 2.000000000003705e+00 0.000000000000000e+00 4.000000000000000e+00 1.224410713963209e+00 1.582386949583891e+01 -8.385906518200370e-10 4.218902865934311e-02 2.533231899625594e+05 1.012883752279690e+05 2.881793309879610e+02 -1.639369909892731e+00 3.797579334078354e-02
-38 1.000000000007407e+00 0.000000000000000e+00 4.000000000000000e+00 1.223905864229122e+00 1.534946693757687e+01 -3.117025067696469e-09 5.206478337208047e-02 2.533214686250497e+05 1.012900863115098e+05 2.883030725452073e+02 -1.398066350326789e+00 3.684463849854551e-02
-39 1.102273827768840e-11 0.000000000000000e+00 4.000000000000000e+00 1.223657281440433e+00 1.386977565647328e+01 -4.380526130133324e-09 1.214361908359071e-01 2.533531727734419e+05 1.013098247782838e+05 2.884178337887705e+02 1.385527892231737e+00 3.329403122360682e-02
-40 -9.999999999925877e-01 0.000000000000000e+00 4.000000000000000e+00 1.223220988934399e+00 1.255823058539649e+01 -3.529055253720887e-09 1.288866702271509e-02 2.533186838813853e+05 1.013016876442055e+05 2.884975314766082e+02 2.379980546477563e-01 3.015114861842997e-02
-41 -1.999999999996295e+00 0.000000000000000e+00 4.000000000000000e+00 1.223334822802493e+00 1.181614083082152e+01 -1.757557824612655e-09 5.137393814076218e-02 2.533738558955629e+05 1.013267156028982e+05 2.885419567804514e+02 3.767536722348031e+00 2.836488932576238e-02
-42 -3.000000000000000e+00 0.000000000000000e+00 3.000000000001386e+00 1.223469387537065e+00 1.104228940550701e+01 2.510089557126533e-09 1.089352111488974e-01 2.534159133318983e+05 1.013464311973510e+05 2.885663578808247e+02 6.547905422512186e+00 2.650424615080931e-02
-43 -3.000000000000000e+00 0.000000000000000e+00 2.000000000008237e+00 1.223349852977387e+00 1.025661047312451e+01 1.795926971076857e-09 3.303270454354446e-01 2.533874658873821e+05 1.013377701556623e+05 2.885698907249557e+02 5.326492125556548e+00 2.463224259119071e-02
-44 -3.000000000000000e+00 0.000000000000000e+00 1.000000000004162e+00 1.223471570471912e+00 9.537437555069435e+00 1.546652853722298e-09 2.999139102701491e-01 2.534105474291288e+05 1.013493346595566e+05 2.885741101062675e+02 6.957362791795996e+00 2.290207946390031e-02
-45 -2.132421637270402e+00 3.000000000000000e-01 0.000000000000000e+00 1.223559777411632e+00 8.423582986700582e+00 3.555111712525681e-09 4.253074005621765e-02 2.534033932870539e+05 1.013497586074257e+05 2.885545137058597e+02 7.017149545298603e+00 2.021689340532926e-02
-46 -1.468963107081476e+00 3.000000000000000e-01 0.000000000000000e+00 1.223888239937025e+00 7.394203154900795e+00 7.129749538693548e-09 7.779523494421796e-02 2.534235751563891e+05 1.013604945583796e+05 2.885076308239301e+02 8.531174500017146e+00 1.774378044113709e-02
-47 -9.616001634889799e-01 3.000000000000000e-01 0.000000000000000e+00 1.224115120806886e+00 6.015982772803537e+00 9.651739101467077e-09 1.385057063556749e-01 2.533735241642001e+05 1.013434933540623e+05 2.884057755842747e+02 6.133599501100322e+00 1.443938078256497e-02
-48 -5.736072649935684e-01 3.000000000000000e-01 0.000000000000000e+00 1.225030865720406e+00 4.110818604595456e+00 9.200552930371555e-09 1.786019921885299e-01 2.534237524098656e+05 1.013667368330585e+05 2.882562815927328e+02 9.411484002049141e+00 9.868531990667838e-03
-49 -2.768996154894059e-01 3.000000000000000e-01 0.000000000000000e+00 1.225373809980145e+00 2.397085469239402e+00 7.018366016480203e-09 -2.630672022295706e-02 2.533882113534333e+05 1.013543465890940e+05 2.881403833297704e+02 7.664164306017439e+00 5.748971647171979e-03
-50 -5.000000000000000e-02 3.000000000000000e-01 1.999999999995579e-01 1.226101907161937e+00 -1.136701186359720e-02 2.730258326930455e-09 2.203637228459090e+00 2.534669697018105e+05 1.013859957530527e+05 2.880591986834714e+02 1.212745071960268e+01 5.282379408010762e-03
-51 -5.000000000000000e-02 3.000000000000000e-01 3.999999999989749e-01 1.225609017522817e+00 7.464508462226017e-02 2.312870047380638e-09 3.748001636707124e+00 2.533695204328277e+05 1.013455149314926e+05 2.880599833827277e+02 6.418690099076450e+00 8.989667459008180e-03
-52 -5.000000000000000e-02 3.000000000000000e-01 5.999999999989468e-01 1.225316773250477e+00 2.568358254154614e-02 2.423264648801799e-09 5.217976866222362e+00 2.533330531118131e+05 1.013287770156381e+05 2.880811006971180e+02 4.058245048387491e+00 1.251563250630456e-02
-53 -5.000000000000000e-02 3.000000000000000e-01 7.999999999994734e-01 1.226479916749085e+00 -1.757659174687510e-01 1.389345477998144e-09 7.501598795356239e+00 2.535877139173857e+05 1.014259040259644e+05 2.880837698002676e+02 1.775546833513042e+01 1.798060619487169e-02
-54 5.000000000000000e-02 3.000000000000000e-01 7.999999999999998e-01 1.225447457309899e+00 -2.570018941450462e-02 7.552659909120378e-09 3.139984549281187e+00 2.532512231057908e+05 1.012988800075163e+05 2.879653900485988e+02 -1.579456330175435e-01 7.532313204873900e-03
-55 5.000000000000000e-02 3.000000000000000e-01 6.000000000013869e-01 1.224381443804761e+00 -1.272503893064051e-01 7.736055449966460e-09 2.365666615958925e+00 2.530011438965832e+05 1.011995407575452e+05 2.879334679210688e+02 -1.416714743404559e+01 5.688126857196431e-03
-56 5.000000000000000e-02 3.000000000000000e-01 4.000000000016644e-01 1.224606997486218e+00 -4.624922184372043e-02 6.921253888591650e-09 1.884188378567659e+00 2.530317389381168e+05 1.012121154209860e+05 2.879162059357481e+02 -1.239382019659189e+01 4.524561297960711e-03
-57 5.000000000000000e-02 3.000000000000000e-01 2.000000000008322e-01 1.224745261720939e+00 -2.426723691769834e-02 6.090758496740050e-09 1.121915474888447e+00 2.530540348798248e+05 1.012214083119048e+05 2.879101347587491e+02 -1.108330109930680e+01 2.693634219826040e-03
-58 2.768996154886466e-01 3.000000000000000e-01 0.000000000000000e+00 1.224524582982858e+00 -1.162310219169254e+00 5.053853528464265e-09 -2.403446258689319e-04 2.530101238834742e+05 1.012038289020247e+05 2.879120095451189e+02 -1.356241686296467e+01 2.790460129613305e-03
-59 5.736072649914844e-01 3.000000000000000e-01 0.000000000000000e+00 1.224474943688190e+00 -1.849797031082721e+00 5.963936140601336e-09 9.007802784714850e-02 2.530096378446336e+05 1.012032949200842e+05 2.879221621095452e+02 -1.363772104298645e+01 4.446334155493176e-03
-60 9.616001634848403e-01 3.000000000000000e-01 0.000000000000000e+00 1.224694585309312e+00 -2.224119191276476e+00 6.933949672806451e-09 1.173410537478959e-02 2.530729095030603e+05 1.012283559518344e+05 2.879418105466702e+02 -1.010351828593620e+01 5.338694789344192e-03
-61 1.468963107074030e+00 3.000000000000000e-01 0.000000000000000e+00 1.224816070195586e+00 -1.389166353223266e+00 4.901718782447396e-09 -1.148821455354788e-01 2.531126286983150e+05 1.012447342102908e+05 2.879598336561559e+02 -7.793793500098639e+00 3.345404262935000e-03
-62 2.132421637265390e+00 3.000000000000000e-01 0.000000000000000e+00 1.224978011401342e+00 4.749880453721124e-01 3.827766367759769e-09 -1.494560843738606e-01 2.531679594482869e+05 1.012671432968306e+05 2.879854929755944e+02 -4.633578221600252e+00 1.194868967253369e-03
-63 3.000000000000000e+00 3.000000000000000e-01 9.999999999976482e-01 1.225527508404324e+00 6.349564926363884e+00 -1.049520539657753e-09 -1.594346869155594e+00 2.533394885810259e+05 1.013288010701624e+05 2.880316321883155e+02 4.061637309597668e+00 1.570104625175790e-02
-64 3.000000000000000e+00 3.000000000000000e-01 1.999999999994776e+00 1.225179076906973e+00 1.106719397355614e+01 -1.827831256952251e-09 -1.451075677765649e+00 2.533246730603412e+05 1.013095312334836e+05 2.880587552199752e+02 1.344131079340759e+00 2.677625609693792e-02
-65 3.000000000000000e+00 3.000000000000000e-01 2.999999999997367e+00 1.224756585600898e+00 1.435687140475060e+01 -1.456259219169721e-09 -4.455427439935816e-01 2.532812788807025e+05 1.012788202429555e+05 2.880707714891506e+02 -2.986850521007113e+00 3.446835934395101e-02
-66 2.000000000003705e+00 3.000000000000000e-01 4.000000000000000e+00 1.224410713962854e+00 1.582386949594774e+01 7.331309197311640e-11 4.218902992650574e-02 2.533231899627825e+05 1.012883752280576e+05 2.881793309882971e+02 -1.639369897388879e+00 3.797579334104173e-02
-67 1.000000000007407e+00 3.000000000000000e-01 4.000000000000000e+00 1.223905864228088e+00 1.534946693853208e+01 2.031182007637734e-09 5.206478491840737e-02 2.533214686251514e+05 1.012900863115457e+05 2.883030725455528e+02 -1.398066345270250e+00 3.684463850085998e-02
-68 1.102273827768840e-11 3.000000000000000e-01 4.000000000000000e+00 1.223657281439966e+00 1.386977565809768e+01 3.446539895956996e-09 1.214361929041482e-01 2.533531727736195e+05 1.013098247783474e+05 2.884178337890615e+02 1.385527901201759e+00 3.329403122754521e-02
-69 -9.999999999925877e-01 3.000000000000000e-01 4.000000000000000e+00 1.223220988934624e+00 1.255823058652139e+01 2.420168483949760e-09 1.288866890169367e-02 2.533186838815844e+05 1.013016876442805e+05 2.884975314767688e+02 2.379980652266765e-01 3.015114862112144e-02
-70 -1.999999999996295e+00 3.000000000000000e-01 4.000000000000000e+00 1.223334822802660e+00 1.181614083158239e+01 1.663205614969289e-09 5.137393941659936e-02 2.533738558956598e+05 1.013267156029340e+05 2.885419567805140e+02 3.767536727398414e+00 2.836488932759519e-02
-71 -3.000000000000000e+00 3.000000000000000e-01 3.000000000001386e+00 1.223469387542753e+00 1.104228940561114e+01 -1.781114163726832e-09 1.089352108085102e-01 2.534159133332825e+05 1.013464311979044e+05 2.885663578810588e+02 6.547905500551988e+00 2.650424615091721e-02
-72 -3.000000000000000e+00 3.000000000000000e-01 2.000000000008237e+00 1.223349852979673e+00 1.025661047237963e+01 -1.187886650988798e-09 3.303270452116930e-01 2.533874658879905e+05 1.013377701559082e+05 2.885698907251169e+02 5.326492160238168e+00 2.463224258933346e-02
-73 -3.000000000000000e+00 3.000000000000000e-01 1.000000000004162e+00 1.223471570475190e+00 9.537437554165878e+00 -7.931637534069747e-10 2.999139103225333e-01 2.534105474300580e+05 1.013493346599312e+05 2.885741101065610e+02 6.957362844618771e+00 2.290207946166372e-02
-74 9.825948741531498e-01 0.000000000000000e+00 9.203063592825887e-01 1.224050217734502e+00 2.934072014905606e+00 -1.483887139725432e-08 -1.781615894302517e+00 2.530014525557864e+05 1.011986557853246e+05 2.880088636571777e+02 -1.429194960871457e+01 8.242818004515434e-03
-75 -9.825948741537733e-01 0.000000000000000e+00 9.203063592817843e-01 1.224095585013595e+00 7.627885265081487e+00 -1.062605927114235e-08 3.320189583997559e+00 2.534064448562708e+05 1.013512702810253e+05 2.884325104794115e+02 7.230331550596713e+00 1.996148218407011e-02
-76 3.134793409687708e-02 0.000000000000000e+00 2.553979665792260e+00 1.223347866056995e+00 1.480236157342753e+01 -9.748077128867006e-09 3.127354796403199e+00 2.532587963775738e+05 1.012660982452402e+05 2.883662658240378e+02 -4.780955402601706e+00 3.632809393469211e-02
-77 -9.606257234580401e-04 0.000000000000000e+00 1.748697432502003e+00 1.223893460052433e+00 1.482762773789029e+01 -1.216515426801025e-08 5.777638517552585e+00 2.532712211931768e+05 1.012671058472562e+05 2.882405842928580e+02 -4.638859504138165e+00 3.820285580766593e-02
-78 -1.129679824287611e+00 0.000000000000000e+00 2.119543773237748e+00 1.223373746009790e+00 1.152011095088080e+01 -5.382427667699478e-09 2.505601079656417e+00 2.533415200327245e+05 1.013138854406062e+05 2.884962419330493e+02 1.958178057568246e+00 2.830187754263280e-02
-79 1.132029953157837e+00 0.000000000000000e+00 2.122440212022948e+00 1.224262025053781e+00 1.456589186487294e+01 -7.196849848206032e-09 -4.812568018288679e-01 2.532719781124976e+05 1.012740933111283e+05 2.881736919570138e+02 -3.653460565742072e+00 3.498030645858563e-02
-80 -5.196051848669313e-01 0.000000000000000e+00 1.412361811251357e+00 1.224233565861935e+00 1.025163571504258e+01 -1.075086471352228e-08 6.861880054886472e+00 2.533793508168682e+05 1.013268788236869e+05 2.883305947580491e+02 3.790554743598473e+00 2.960208779857871e-02
-81 5.497855166715109e-01 0.000000000000000e+00 1.395413135418834e+00 1.223859671765026e+00 1.029583548127179e+01 -1.285493196227323e-08 -3.120091285902361e-01 2.530702184365128e+05 1.012107485276112e+05 2.880881255264606e+02 -1.258658473964613e+01 2.473533366019806e-02
-82 5.374226884505656e-01 0.000000000000000e+00 4.938127011549980e-01 1.224505550598270e+00 -9.283163013960116e-01 -1.190197352855585e-08 7.227085577122649e-01 2.530322279953929e+05 1.012126651348593e+05 2.879416228849931e+02 -1.231629743910379e+01 2.824350447491338e-03
-83 -5.374226884502991e-01 0.000000000000000e+00 4.938127011534965e-01 1.224684999683560e+00 4.038397988424951e+00 -8.417293122716291e-09 3.197433584665827e+00 2.533461082042517e+05 1.013341103732633e+05 2.882448827288223e+02 4.810375583595602e+00 1.235756520206840e-02
-84 -1.601042872495425e-04 0.000000000000000e+00 1.423899928231195e+00 1.224663697010594e+00 1.333885487066113e+01 -7.819432925239895e-09 6.420077853650795e+00 2.533314473089214e+05 1.012967907395238e+05 2.881437391188526e+02 -4.525822135342037e-01 3.552163702769896e-02
-85 4.652818771299120e-01 0.000000000000000e+00 8.722244593273728e-01 1.224453933331923e+00 1.081500387233937e+00 -9.481514757671478e-09 4.452336255663349e-01 2.530610338703448e+05 1.012241901218363e+05 2.879865501732565e+02 -1.069099960001128e+01 2.807669454984802e-03
-86 -4.652818771308316e-01 0.000000000000000e+00 8.722244593264402e-01 1.224555309269862e+00 5.325805583934722e+00 -7.844153886569123e-09 6.595941983740227e+00 2.533410309785939e+05 1.013246741456880e+05 2.882485660247008e+02 3.479642601601123e+00 2.034065694310641e-02
-87 -1.779160986901294e+00 0.000000000000000e+00 8.965036540400221e-01 1.223621528107065e+00 8.924295258948320e+00 -4.830718006437960e-09 1.235867130983409e+00 2.534083468323709e+05 1.013500714911469e+05 2.885408424238517e+02 7.061273606954066e+00 2.162216996384479e-02
-88 1.779160986895464e+00 0.000000000000000e+00 8.965036540386054e-01 1.224434600261200e+00 4.479797354871245e+00 -6.291049092568107e-09 -2.419437807186817e+00 2.530997370997735e+05 1.012356606793200e+05 2.880237319780139e+02 -9.073377616696598e+00 1.222187637102927e-02
-89 -3.024549228140815e-01 0.000000000000000e+00 1.271810638079400e+00 1.223954304752371e+00 9.849029160735682e+00 -7.723844607101912e-09 9.233807205153159e+00 2.532314842167028e+05 1.012628104553622e+05 2.882140298618379e+02 -5.244612133378841e+00 3.241021434750511e-02
-90 3.084909891748027e-01 0.000000000000000e+00 1.268420902912950e+00 1.223668512185235e+00 9.108840989472711e+00 -8.577953824638598e-09 1.064677273158373e+00 2.530093585495407e+05 1.011899971280665e+05 2.880740538119987e+02 -1.551302664412771e+01 2.202647350640896e-02
-91 -1.906003421713626e-05 0.000000000000000e+00 1.200234358426896e+00 1.223041788782746e+00 1.022088490847032e+01 -3.287447055111325e-09 6.470264991277401e+00 2.529161756521481e+05 1.011425412637126e+05 2.880865020511280e+02 -2.220543453495377e+01 2.906807704487655e-02
-92 -5.618007820408263e-01 0.000000000000000e+00 2.043746239937465e+00 1.223921332804616e+00 1.281268701854214e+01 -9.449831548487558e-09 4.264715283902162e+00 2.534115096122905e+05 1.013348057295961e+05 2.884267125726451e+02 4.908437398973192e+00 3.240679359176214e-02
-93 -8.083224307437241e-01 0.000000000000000e+00 2.889383374999068e+00 1.223330644599528e+00 1.254801098531849e+01 -3.274648743380506e-09 1.566657494682722e+00 2.533353875832712e+05 1.013080121428153e+05 2.884896813825160e+02 1.129903090582649e+00 3.035819102105227e-02
-94 5.647434910278286e-01 0.000000000000000e+00 2.014946179016490e+00 1.224336163528867e+00 1.567196204796147e+01 -1.281042708633387e-08 1.479640888056810e+00 2.533299019781645e+05 1.012914817563451e+05 2.882057174077407e+02 -1.201275370873489e+00 3.777892509885856e-02
-95 8.221850434196895e-01 0.000000000000000e+00 2.852649226946881e+00 1.223865511325447e+00 1.589359120556003e+01 -5.424988696735506e-09 1.132995407181057e+00 2.532912817224423e+05 1.012750228491779e+05 2.882697016721770e+02 -3.522373547047881e+00 3.825081459383542e-02
-96 -1.158518924678652e+00 0.000000000000000e+00 1.551501353485399e+00 1.223655841375822e+00 1.021422016505321e+01 -7.260009944252492e-09 3.059935617884134e+00 2.533898588081560e+05 1.013373609290849e+05 2.884965656737903e+02 5.268781425035565e+00 2.559112396523932e-02
-97 1.158988950451789e+00 0.000000000000000e+00 1.552080641242281e+00 1.224526569726145e+00 1.117132817861145e+01 -1.110928716915788e-08 -2.354730156319659e+00 2.532226024958016e+05 1.012677522275245e+05 2.880933958481753e+02 -4.547704481100870e+00 2.740063908199725e-02
-98 -2.216781681457610e+00 0.000000000000000e+00 1.838237906171512e+00 1.223470618038069e+00 1.027133285814820e+01 -9.793014564317290e-10 7.714299412015206e-01 2.534062936884735e+05 1.013451741274948e+05 2.885624883718388e+02 6.370628613004436e+00 2.472213169728857e-02
-99 2.216781681455013e+00 0.000000000000000e+00 1.838237906163890e+00 1.224852511264242e+00 1.112031498301583e+01 1.538871448153996e-09 -1.976584240004375e+00 2.532753527414556e+05 1.012893111126607e+05 2.880780481101446e+02 -1.507387863386619e+00 2.710089558671956e-02
-100 9.670971517162510e-01 0.000000000000000e+00 4.607420247048584e-01 1.224603197552099e+00 -7.405238266319678e-01 -1.451530534885870e-08 -5.388237978838964e-01 2.530703532897409e+05 1.012280043398334e+05 2.879622983870887e+02 -1.015310395805616e+01 2.198330504734991e-03
-101 -9.670971517153459e-01 0.000000000000000e+00 4.607420247046419e-01 1.224348335121807e+00 6.280835987149466e+00 -9.810098049794732e-09 1.918738231339656e+00 2.534180273061592e+05 1.013601654672022e+05 2.883982768146611e+02 8.484764800757107e+00 1.575585080152454e-02
-102 1.854114598533743e+00 0.000000000000000e+00 3.012715418354706e+00 1.224443019364885e+00 1.537143392421728e+01 9.827411485317509e-10 -3.141849808996237e-01 2.533053825215005e+05 1.012835428504548e+05 2.881579793211872e+02 -2.320850309581173e+00 3.689795801799008e-02
-103 -1.854114598532094e+00 0.000000000000000e+00 3.012715418358399e+00 1.223177562005783e+00 1.142059764420512e+01 -8.567415438148068e-10 5.438506198815362e-01 2.533432257872316e+05 1.013159155238389e+05 2.885482951928631e+02 2.244468176401496e+00 2.744941458983653e-02
-104 3.467727762006756e-01 0.000000000000000e+00 3.138478024891123e-01 1.224476376768595e+00 -1.108362807903355e+00 -9.085586661325817e-09 9.893348634709823e-01 2.530073832587307e+05 1.012025927817823e+05 2.879198275637158e+02 -1.373673927764037e+01 3.566899524340820e-03
-105 -3.467727761998039e-01 0.000000000000000e+00 3.138478024875392e-01 1.225524406744757e+00 2.434357025709125e+00 -5.907770745311075e-09 2.420917139084993e+00 2.534310260483256e+05 1.013704868454123e+05 2.881508551363698e+02 9.940325118082173e+00 8.232270989660275e-03
-106 2.714569979187768e-01 0.000000000000000e+00 7.206820098998908e-01 1.224066699668056e+00 -1.043463490801533e-01 -6.573802909558755e-09 1.873870634278800e+00 2.529560026495223e+05 1.011818255553343e+05 2.879570878750829e+02 -1.666541315269206e+01 4.507067696542078e-03
-107 -2.714569979194104e-01 0.000000000000000e+00 7.206820098987166e-01 1.224881969575043e+00 2.239168983943814e+00 -5.877682581371957e-09 6.113591249728760e+00 2.533161276564976e+05 1.013195295996727e+05 2.881570625223411e+02 2.754139003347393e+00 1.561972381262484e-02
-108 -2.889797296894188e-01 0.000000000000000e+00 9.267545678931778e-01 1.225102117102039e+00 4.087795404281581e+00 -5.757558236297365e-09 8.727547336429677e+00 2.533945306843056e+05 1.013426494309713e+05 2.881710234501992e+02 6.014586232030846e+00 2.311613237855640e-02
-109 2.889797296888021e-01 0.000000000000000e+00 9.267545678937171e-01 1.222911668889950e+00 1.238583118303994e+00 -5.597468671897344e-09 1.129694631654618e+00 2.527501138081779e+05 1.010995859155704e+05 2.879947912760591e+02 -2.826316237901434e+01 4.029395937824180e-03
-110 -2.096255493199925e-01 0.000000000000000e+00 1.496037590846734e+00 1.224438384635492e+00 1.247044961431702e+01 -9.742805303847337e-09 7.922336447710388e+00 2.533644530686524e+05 1.013101280608969e+05 2.882347069169185e+02 1.428297968821045e+00 3.545223392226562e-02
-111 2.517633613169607e-01 0.000000000000000e+00 1.518247420292257e+00 1.223834798175103e+00 1.341832851803302e+01 -1.058307029134579e-08 3.247594209866509e+00 2.531433946850740e+05 1.012262101392774e+05 2.881379918256525e+02 -1.040612899768025e+01 3.315032034144384e-02
-112 -6.660432832766596e-01 0.000000000000000e+00 1.081962603010036e+00 1.224355684220163e+00 7.751902521756274e+00 -1.023591306644296e-08 5.677689451790870e+00 2.533944897261627e+05 1.013427139740893e+05 2.883468916017145e+02 6.023688349920881e+00 2.305435536857013e-02
-113 6.589236055220503e-01 0.000000000000000e+00 1.065642443794388e+00 1.224063977939055e+00 4.552762685465925e+00 -1.329109889450171e-08 -1.077215936246549e+00 2.530229866428337e+05 1.012056183665738e+05 2.880254411423164e+02 -1.331005971318074e+01 1.123401685388432e-02
-114 -2.065827934826303e-01 0.000000000000000e+00 1.069425960577202e+00 1.224784675725177e+00 6.668159261111649e+00 -4.850109648580958e-09 1.010624105650994e+01 2.533218708372165e+05 1.013048093586519e+05 2.881380846842428e+02 6.782341914956013e-01 2.905084300103755e-02
-115 2.065827934823721e-01 0.000000000000000e+00 1.069425960577464e+00 1.224356063932627e+00 3.844412983960402e+00 -4.627425729148292e-09 8.274021835271036e-01 2.530940845772032e+05 1.012351077510879e+05 2.880406340354466e+02 -9.151353675371539e+00 9.440151019868490e-03
-116 -2.339028924130573e-01 0.000000000000000e+00 4.854032749601151e-01 1.225573798906743e+00 1.373451413348444e+00 -5.437923740771996e-09 4.093935194857225e+00 2.534138240115988e+05 1.013624866750043e+05 2.881165023133914e+02 8.812110422261533e+00 1.035448041706084e-02
-117 2.339028924126051e-01 0.000000000000000e+00 4.854032749623373e-01 1.224566438328099e+00 -4.887605592048566e-01 -7.788710376800512e-09 1.781265834474075e+00 2.530322980124662e+05 1.012123619800372e+05 2.879264434824593e+02 -1.235904949411984e+01 4.434242916932016e-03
-118 -6.934692988371788e-01 0.000000000000000e+00 7.488579429535888e-01 1.224562935333679e+00 5.957897322062600e+00 -1.015672665235056e-08 4.175196362145291e+00 2.534045462316951e+05 1.013531739708432e+05 2.883278467687612e+02 7.498797185619622e+00 1.745310877257088e-02
-119 6.931604137473489e-01 0.000000000000000e+00 7.481498977313378e-01 1.224059284708415e+00 7.202425782996872e-01 -1.331683401037212e-08 -2.715534554232718e-01 2.529702014785474e+05 1.011879837839100e+05 2.879763582629417e+02 -1.579695615428314e+01 1.848464164882260e-03
-120 -1.312362884067610e+00 0.000000000000000e+00 6.646874262097189e-01 1.223694603123973e+00 7.810289706356100e+00 -8.686928215348654e-09 1.667189870350517e+00 2.533756612418204e+05 1.013398403031102e+05 2.884944855446279e+02 5.618432253585819e+00 1.916691033622783e-02
-121 1.312362884063586e+00 0.000000000000000e+00 6.646874262090433e-01 1.224645642483548e+00 1.664131861532885e+00 -1.318817671629217e-08 -1.819589006412953e+00 2.531088699600022e+05 1.012425550046779e+05 2.879937086134725e+02 -8.101113428588240e+00 5.918471199390108e-03
-122 -1.380533872983328e-01 0.000000000000000e+00 3.181603062552175e+00 1.223450074585087e+00 1.392689574992168e+01 -4.860867244131587e-09 1.554867235164374e+00 2.533147668284723e+05 1.012938047206199e+05 2.884210659716077e+02 -8.736820448600866e-01 3.364307318626503e-02
-123 7.419949146702542e-01 0.000000000000000e+00 2.620513753100355e-01 1.224116232951613e+00 -1.956940612578064e+00 -1.249423036664678e-08 1.530185500442936e-01 2.529459269840567e+05 1.011777412731353e+05 2.879338126889628e+02 -1.724139428355512e+01 4.713933251256076e-03
-124 -7.419949146691938e-01 0.000000000000000e+00 2.620513753103896e-01 1.225088366895090e+00 5.004263359308250e+00 -8.361868283062048e-09 1.095017514544010e+00 2.534926255394002e+05 1.013927661631422e+05 2.883167679480856e+02 1.308223990159481e+01 1.228414394205879e-02
-125 2.375341278589752e+00 0.000000000000000e+00 5.856470294858179e-01 1.224421467614219e+00 3.109231532092787e+00 -1.721787125214293e-09 -1.350802400099359e+00 2.530809759054453e+05 1.012305132327503e+05 2.880121761400550e+02 -9.799290262260778e+00 8.137900472429592e-03
-126 -2.375341278594772e+00 0.000000000000000e+00 5.856470294875045e-01 1.223663251334879e+00 8.963591510657070e+00 -2.193266099210668e-09 4.253140933388749e-01 2.534362454679819e+05 1.013613365817004e+05 2.885630743578195e+02 8.649919856209223e+00 2.153472124988626e-02
-127 2.370934994068257e+00 0.000000000000000e+00 2.530901175131019e+00 1.224947072363209e+00 1.391069059528092e+01 2.544270528552403e-09 -9.533153904752071e-01 2.533354431741600e+05 1.013024344903296e+05 2.880931310792431e+02 3.433211577554896e-01 3.345288042211800e-02
-128 -2.370934994068034e+00 0.000000000000000e+00 2.530901175137551e+00 1.223429922909319e+00 1.090553836580806e+01 -4.768176176346423e-10 4.540008629912676e-01 2.534030231130562e+05 1.013417333632613e+05 2.885622895736796e+02 5.885398852247396e+00 2.619843730169610e-02
-129 -1.790781052807056e-01 0.000000000000000e+00 2.118264311918558e+00 1.223638627448767e+00 1.450435713346763e+01 -1.178203528600435e-08 4.708078995724238e+00 2.533122998663526e+05 1.012869116034781e+05 2.883569983677079e+02 -1.845775845699154e+00 3.660865628840751e-02
-130 -7.921348971844293e-01 0.000000000000000e+00 1.723545051111688e+00 1.223530799364389e+00 1.116245450794546e+01 -9.971125031356532e-09 4.517234385859516e+00 2.533231383825179e+05 1.013055525092023e+05 2.884354849497487e+02 7.830361306306212e-01 2.890710413154786e-02
-131 7.983255105839553e-01 0.000000000000000e+00 1.699241333964839e+00 1.223720865301772e+00 1.338013306788767e+01 -1.328444700948142e-08 -9.470712997360327e-01 2.531049667869495e+05 1.012125805143851e+05 2.881260185088981e+02 -1.232823094272979e+01 3.221240803691083e-02
-132 -4.642644325923871e-01 0.000000000000000e+00 2.484420071406212e+00 1.223479033952845e+00 1.344219786815719e+01 -7.243713607726898e-09 3.076475527366520e+00 2.533321164451393e+05 1.013017618794348e+05 2.884368955836347e+02 2.484669912254950e-01 3.310440720402026e-02
-133 -1.296959501136076e+00 0.000000000000000e+00 1.140605243476817e+00 1.223647829655848e+00 8.968983867059913e+00 -8.211788241503540e-09 2.468125009407343e+00 2.533823260301008e+05 1.013387867490398e+05 2.885025137607442e+02 5.469856020277982e+00 2.232616263440487e-02
-134 1.297037838762715e+00 0.000000000000000e+00 1.140701791435802e+00 1.224659062584331e+00 6.434502264440670e+00 -1.168804533099116e-08 -2.678401501354437e+00 2.531713426183785e+05 1.012606039571587e+05 2.880418940446716e+02 -5.555780967604415e+00 1.672714892736600e-02
-135 -4.081579652100921e-01 0.000000000000000e+00 1.105756673356268e+00 1.224527743576370e+00 7.464364297763586e+00 -7.818500882137455e-09 8.396141820740533e+00 2.533517162008112e+05 1.013200725036292e+05 2.882419638183719e+02 2.830701400257773e+00 2.695591813456403e-02
-136 4.130074186115749e-01 0.000000000000000e+00 1.099646911654121e+00 1.223865905398007e+00 4.725620969760575e+00 -9.369701759287866e-09 -1.090344764310347e-01 2.529898243298365e+05 1.011922784524981e+05 2.880340848879252e+02 -1.519130552840274e+01 1.135193335105250e-02
-137 -3.772008574027238e-01 0.000000000000000e+00 1.757108739594634e+00 1.223761985978498e+00 1.296735981451169e+01 -1.175558653440298e-08 6.068411810894018e+00 2.533158988365117e+05 1.012928598762047e+05 2.883448638234058e+02 -1.006927625903455e+00 3.436780195407958e-02
-138 -4.919077155844299e-01 0.000000000000000e+00 7.088942783330604e-01 1.225548251888730e+00 4.505913302394341e+00 -8.096733631078675e-09 4.917879415494944e+00 2.535307087926602e+05 1.014050232900488e+05 2.882434183882527e+02 1.481078691987499e+01 1.599065855758942e-02
-139 4.918304943116507e-01 0.000000000000000e+00 7.087172670283998e-01 1.224495166961078e+00 -4.060538125128428e-01 -9.574669610348187e-09 7.414165304195931e-01 2.530430790731796e+05 1.012171149153493e+05 2.879567239738402e+02 -1.168877233827557e+01 2.029342448881232e-03
-140 -3.812006875457408e-06 0.000000000000000e+00 1.075683673435016e+00 1.227303890549546e+00 7.087819497334451e+00 -7.658950774753755e-10 4.854507315072281e+00 2.537465160779090e+05 1.014865795114956e+05 2.880625824210088e+02 2.631215787556646e+01 2.057282262681941e-02
-141 1.951707213103545e-01 0.000000000000000e+00 2.080383973855081e+00 1.223795891268290e+00 1.558481692584084e+01 -1.305882233151861e-08 3.713218879313998e+00 2.532900424062014e+05 1.012740696876304e+05 2.882833876993025e+02 -3.656792041972919e+00 3.846127959273665e-02
-142 -1.661418383658756e+00 0.000000000000000e+00 1.556854534039652e+00 1.223499202339664e+00 1.001131830274181e+01 -4.045538547956617e-09 1.679226525472291e+00 2.533891646514039e+05 1.013388213386059e+05 2.885376587375740e+02 5.474733973472341e+00 2.436477499557512e-02
-143 1.661832453980385e+00 0.000000000000000e+00 1.557364858964508e+00 1.223784548869239e+00 9.878683723805084e+00 -3.844688537144376e-09 -2.397572778302496e+00 2.530495564534075e+05 1.012029345192547e+05 2.880835667218763e+02 -1.368854614938798e+01 2.441261714276945e-02
-144 5.290562426421479e-01 0.000000000000000e+00 3.385983609739860e+00 1.223526745484914e+00 1.514732263283535e+01 -3.444280185026010e-09 8.152588809285369e-01 2.532750989434215e+05 1.012724260097314e+05 2.883421230844893e+02 -3.888589799551292e+00 3.642064573240143e-02
-145 -1.371705261972805e-01 0.000000000000000e+00 1.258416746755928e+00 1.224516442088783e+00 1.086146428894737e+01 -5.539418690929295e-09 8.951848777823287e+00 2.532900877715301e+05 1.012836783355657e+05 2.881410866402325e+02 -2.301743679925024e+00 3.377799390915374e-02
-146 1.451397844830034e-01 0.000000000000000e+00 1.261553429135801e+00 1.223843144742910e+00 1.030381604470938e+01 -5.792881882080452e-09 3.143120454241849e+00 2.530690441191919e+05 1.012086531534486e+05 2.880860515341334e+02 -1.288208243567719e+01 2.586918782175862e-02
-147 -1.670022720633292e+00 0.000000000000000e+00 3.934843812824604e-01 1.223620404217295e+00 8.109840990127607e+00 -5.541651780083674e-09 5.952527602954258e-01 2.533944876008327e+05 1.013469871383880e+05 2.885323263724812e+02 6.626306358485911e+00 1.951579560908036e-02
-148 1.670022720624052e+00 0.000000000000000e+00 3.934843812811255e-01 1.224677047194735e+00 7.529160614893630e-01 -8.762860751711392e-09 -9.949315100790092e-01 2.531056664936925e+05 1.012420123637083e+05 2.879847799638088e+02 -8.177638738070057e+00 2.994726857651685e-03
-149 1.262577532593635e+00 0.000000000000000e+00 3.364522470067870e+00 1.224046277543559e+00 1.578759167583465e+01 -1.065620510557867e-09 2.828569650934125e-01 2.533059188295397e+05 1.012816291931501e+05 2.882459317746691e+02 -2.590721597783355e+00 3.790157889653364e-02
-150 -1.262577532594160e+00 0.000000000000000e+00 3.364522470071912e+00 1.223182758187803e+00 1.210989213808023e+01 -2.013919801068355e-09 5.923814076050223e-01 2.533260800087968e+05 1.013063962815722e+05 2.885199586755697e+02 9.020281444310618e-01 2.910925808644750e-02
-151 -2.259570044434444e+00 0.000000000000000e+00 1.141342455190163e+00 1.223375227255385e+00 9.608300787242094e+00 -1.767487772771279e-09 7.669337581922566e-01 2.533820373442297e+05 1.013376261993003e+05 2.885634955150313e+02 5.306190847591305e+00 2.313643664007476e-02
-152 2.259570044423067e+00 0.000000000000000e+00 1.141342455181824e+00 1.225610333580298e+00 7.331550896697258e+00 8.967530044092293e-10 -2.295465307245661e+00 2.533759210286138e+05 1.013407371611353e+05 2.880460939572513e+02 5.744910609966420e+00 1.842342156822686e-02
-153 4.855341639785172e-01 0.000000000000000e+00 2.466426775981777e+00 1.224263605423180e+00 1.577588472490216e+01 -1.053109583150656e-08 2.208635004842823e+00 2.533838173822841e+05 1.013120723827845e+05 2.882813886174047e+02 1.702493694045645e+00 3.822756124469365e-02
-154 -1.276009205397341e+00 0.000000000000000e+00 3.037827664393642e-01 1.224181183016565e+00 7.149953130693396e+00 -7.686253813260820e-09 6.581982316327900e-01 2.534604543678860e+05 1.013757589653965e+05 2.884820292435854e+02 1.068381968643307e+01 1.722589116371053e-02
-155 1.276009205392552e+00 0.000000000000000e+00 3.037827664390054e-01 1.224591741295600e+00 -1.083393523078688e+00 -1.279266603319641e-08 -6.447577308859346e-01 2.530681574048031e+05 1.012270033727041e+05 2.879621448537105e+02 -1.029426417937424e+01 3.026328852865807e-03
-156 2.135573730685918e-01 0.000000000000000e+00 1.580206643002382e-01 1.224613228938396e+00 -7.116074572101130e-01 -5.384379111920997e-09 6.506868576865139e-01 2.530281542015227e+05 1.012111098320845e+05 2.879118803069827e+02 -1.253563219793036e+01 2.314793099230042e-03
-157 3.890522885319399e-01 0.000000000000000e+00 1.526836842918348e-01 1.224740580794198e+00 -1.442143611505463e+00 -7.928769722535178e-09 2.737261719046351e-01 2.530581947933213e+05 1.012229260543712e+05 2.879155521664266e+02 -1.086926323915222e+01 3.523451638416075e-03
-158 5.300891290855102e-01 0.000000000000000e+00 2.792970282796143e-01 1.224826238530732e+00 -1.518834726092703e+00 -1.128561787818704e-08 4.521533418695753e-01 2.530829588189537e+05 1.012327734609955e+05 2.879234246253024e+02 -9.480544211601060e+00 3.803536671971383e-03
-159 -2.135573730679655e-01 0.000000000000000e+00 1.580206642994352e-01 1.225574792584433e+00 1.477527512437687e+00 -3.723599246579811e-09 1.349010769000732e+00 2.533961316016326e+05 1.013577994095929e+05 2.881029454660996e+02 8.151094287537951e+00 4.797619611556662e-03
-160 -3.890522885318832e-01 0.000000000000000e+00 1.526836842909433e-01 1.225804487581637e+00 2.914333494607870e+00 -5.137642271142035e-09 7.801372926849853e-01 2.535056280916506e+05 1.014007661786423e+05 2.881710672126028e+02 1.421043275170312e+01 7.232227458151557e-03
-161 -5.300891290842963e-01 0.000000000000000e+00 2.792970282778868e-01 1.224930330232542e+00 3.824266949149579e+00 -7.068194915943710e-09 1.494990333061606e+00 2.533791143018849e+05 1.013488929088791e+05 2.882291931919528e+02 6.895065418015555e+00 9.849172557140608e-03
-162 -7.875523834420067e-02 0.000000000000000e+00 1.120752147839008e+00 1.223592701312725e+00 7.820450318190669e+00 -2.405781715934555e-09 9.506185089533561e+00 2.530306252031261e+05 1.011874825261689e+05 2.880847430197412e+02 -1.586764544226737e+01 2.956644829631406e-02
-163 8.033994118485660e-02 0.000000000000000e+00 1.121379484315036e+00 1.224276596419388e+00 7.089866153876917e+00 -1.818493394718361e-09 1.569687967046442e+00 2.531086798790630e+05 1.012348578651437e+05 2.880586196492790e+02 -9.186593549044225e+00 1.743253554433281e-02
-164 -1.773494387528787e+00 0.000000000000000e+00 2.251338641411685e+00 1.223250770677493e+00 1.090056693585978e+01 -1.475335237428104e-09 1.121745011006397e+00 2.533525641802116e+05 1.013213926296584e+05 2.885466241528949e+02 3.016870632972844e+00 2.630656913220086e-02
-165 1.773729438481018e+00 0.000000000000000e+00 2.251628332197096e+00 1.224699321548360e+00 1.374274965944460e+01 -4.921065808893409e-10 -1.364654056157814e+00 2.533148931710595e+05 1.012948107746617e+05 2.881297255356170e+02 -7.318044476536594e-01 3.313843295018460e-02
-166 5.131609952661074e-01 0.000000000000000e+00 1.722883911813639e+00 1.224931076748584e+00 1.458181597752423e+01 -1.263717471799513e-08 1.355211949386627e+00 2.533914554089589e+05 1.013215653433393e+05 2.881512998890966e+02 3.041227378274632e+00 3.513244640101040e-02
-167 1.562483280349060e-01 0.000000000000000e+00 9.024089340530100e-01 1.224968806644761e+00 -5.386328674521780e-01 -2.436154408017868e-09 2.808620074404992e+00 2.531714463188979e+05 1.012672432328081e+05 2.879879411807819e+02 -4.619484866995620e+00 6.862384713886760e-03
-168 -1.562483280352914e-01 0.000000000000000e+00 9.024089340525773e-01 1.225667425100133e+00 2.159649957143969e+00 -3.956295384562987e-09 9.218549846477156e+00 2.534547899045802e+05 1.013672878910563e+05 2.881081398037509e+02 9.489196313117452e+00 2.270207725837133e-02
-169 -2.398406843342383e+00 0.000000000000000e+00 3.398406843344410e+00 1.223264152187349e+00 1.139765760459801e+01 -8.011741289708583e-10 1.429988403430738e-01 2.533707730832697e+05 1.013270665528439e+05 2.885596259098717e+02 3.817029028889420e+00 2.736294941608738e-02
-170 2.398406843344079e+00 0.000000000000000e+00 3.398406843341552e+00 1.224814473799855e+00 1.544644406546602e+01 1.420822224177598e-09 -1.755587537690204e-01 2.533395483271112e+05 1.012968544981701e+05 2.881084494663551e+02 -4.435907248425333e-01 3.706460808022331e-02
-171 -9.026427775494201e-01 0.000000000000000e+00 1.305047070269513e+00 1.223810619828932e+00 9.317122464695096e+00 -1.048428032279249e-08 4.350250859483027e+00 2.533674473665088e+05 1.013296995649983e+05 2.884382704557680e+02 4.188346495318015e+00 2.467838326838357e-02
-172 9.076093826908616e-01 0.000000000000000e+00 1.295564284189789e+00 1.223992801823983e+00 8.198213854405125e+00 -1.425770457075797e-08 -2.121028588815580e+00 2.530624255651882e+05 1.012132529230698e+05 2.880639188190184e+02 -1.223340529264880e+01 2.033368649024478e-02
-173 1.368927313237185e+00 0.000000000000000e+00 2.720791131917900e+00 1.224153104741834e+00 1.562503615029123e+01 -2.262106160370205e-09 -5.954085569508674e-02 2.532834829944213e+05 1.012735051643410e+05 2.881976588043194e+02 -3.736403280069651e+00 3.750544961170742e-02
-174 -1.365637754737275e+00 0.000000000000000e+00 2.727500735615763e+00 1.223529537264898e+00 1.159185082614325e+01 -1.383061760352795e-09 1.197782764402049e+00 2.534018748509619e+05 1.013385509357853e+05 2.885297351462335e+02 5.436600731257133e+00 2.797051030982572e-02
-175 -6.417906701235564e-01 0.000000000000000e+00 3.487101781524630e+00 1.223101522439131e+00 1.283243467823560e+01 -3.139587562074834e-09 5.323642694954362e-01 2.532805134611614e+05 1.012852321874796e+05 2.884788423391882e+02 -2.082613527061986e+00 3.083998316768403e-02
-176 3.460139993677798e-01 0.000000000000000e+00 2.888128468202591e+00 1.223825838752209e+00 1.526391304331128e+01 -7.150484544050726e-09 2.126786940875602e+00 2.533451356335104e+05 1.012992398638783e+05 2.883479801257388e+02 -1.071973095083792e-01 3.699255013477752e-02
-177 1.788466083363745e-01 0.000000000000000e+00 3.114543483508369e-01 1.224454524560556e+00 -3.373364516550983e-01 -6.418597592254890e-09 1.407246519939397e+00 2.529977697283649e+05 1.011987658388470e+05 2.879140781319170e+02 -1.427642943914399e+01 3.474399549412833e-03
-178 -1.788466083361653e-01 0.000000000000000e+00 3.114543483491244e-01 1.225419916748484e+00 8.086640658062453e-01 -4.091591893411636e-09 2.878300264954753e+00 2.533471291181994e+05 1.013373927922596e+05 2.880813458127732e+02 5.273274892063101e+00 7.170380265462041e-03
-179 2.711768521854932e-01 0.000000000000000e+00 1.797395744097217e+00 1.223027344531864e+00 1.541375521570043e+01 -1.229175787552441e-08 3.570953876499728e+00 2.530606640323675e+05 1.011833285787005e+05 2.882060811921360e+02 -1.645345103645867e+01 3.801234755148547e-02
-180 9.825948741531498e-01 3.000000000000000e-01 9.203063592825887e-01 1.224050217729650e+00 2.934072026940205e+00 1.481666996303007e-08 -1.781615903318222e+00 2.530014525551433e+05 1.011986557850506e+05 2.880088636575396e+02 -1.429194964735688e+01 8.242818040481138e-03
-181 -9.825948741537733e-01 3.000000000000000e-01 9.203063592817843e-01 1.224095585011420e+00 7.627885266442813e+00 1.086733748365913e-08 3.320189592803404e+00 2.534064448562442e+05 1.013512702810017e+05 2.884325104798567e+02 7.230331547268098e+00 1.996148219551793e-02
-182 3.134793409687708e-02 3.000000000000000e-01 2.553979665792260e+00 1.223347866055559e+00 1.480236157808201e+01 9.196891056422945e-09 3.127354801247906e+00 2.532587963777444e+05 1.012660982452808e+05 2.883662658244924e+02 -4.780955396863847e+00 3.632809394804581e-02
-183 -9.606257234580401e-04 3.000000000000000e-01 1.748697432502003e+00 1.223893460050248e+00 1.482762774640083e+01 1.293090259327544e-08 5.777638525166880e+00 2.532712211931700e+05 1.012671058471977e+05 2.882405842932064e+02 -4.638859512377615e+00 3.820285583338439e-02
-184 -1.129679824287611e+00 3.000000000000000e-01 2.119543773237748e+00 1.223373746008041e+00 1.152011095269629e+01 5.122068377244159e-09 2.505601083914491e+00 2.533415200325322e+05 1.013138854405189e+05 2.884962419332132e+02 1.958178045257297e+00 2.830187754909641e-02
-185 1.132029953157837e+00 3.000000000000000e-01 2.122440212022948e+00 1.224262025053893e+00 1.456589187111095e+01 7.098905108881969e-09 -4.812568016417447e-01 2.532719781131537e+05 1.012740933113611e+05 2.881736919576500e+02 -3.653460532909454e+00 3.498030647349338e-02
-186 -5.196051848669313e-01 3.000000000000000e-01 1.412361811251357e+00 1.224233565859746e+00 1.025163571964106e+01 1.100191383440468e-08 6.861880064805843e+00 2.533793508169287e+05 1.013268788236734e+05 2.883305947585265e+02 3.790554741700219e+00 2.960208782101712e-02
-187 5.497855166715109e-01 3.000000000000000e-01 1.395413135418834e+00 1.223859671760978e+00 1.029583549452056e+01 1.416362580698924e-08 -3.120091305699839e-01 2.530702184358525e+05 1.012107485273022e+05 2.880881255265340e+02 -1.258658478321569e+01 2.473533369222115e-02
-188 5.374226884505656e-01 3.000000000000000e-01 4.938127011549980e-01 1.224505550593246e+00 -9.283162923506628e-01 1.216258452553608e-08 7.227085482665965e-01 2.530322279946906e+05 1.012126651345834e+05 2.879416228853894e+02 -1.231629747801698e+01 2.824350416436099e-03
-189 -5.374226884502991e-01 3.000000000000000e-01 4.938127011534965e-01 1.224684999682023e+00 4.038397989811369e+00 9.339111240836420e-09 3.197433592508965e+00 2.533461082044117e+05 1.013341103733173e+05 2.882448827293375e+02 4.810375591211193e+00 1.235756521636079e-02
-190 -1.601042872495425e-04 3.000000000000000e-01 1.423899928231195e+00 1.224663697008107e+00 1.333885487953918e+01 1.017417875172552e-08 6.420077859224841e+00 2.533314473086630e+05 1.012967907393700e+05 2.881437391190002e+02 -4.525822352215031e-01 3.552163705275829e-02
-191 4.652818771299120e-01 3.000000000000000e-01 8.722244593273728e-01 1.224453933329168e+00 1.081500397232569e+00 1.155035834459577e-08 4.452336192054491e-01 2.530610338696929e+05 1.012241901215729e+05 2.879865501731551e+02 -1.069099963715344e+01 2.807669471374134e-03
-192 -4.652818771308316e-01 3.000000000000000e-01 8.722244593264402e-01 1.224555309268106e+00 5.325805586866113e+00 8.650046709927803e-09 6.595941992175088e+00 2.533410309787781e+05 1.013246741457383e+05 2.882485660252574e+02 3.479642608707777e+00 2.034065696328033e-02
-193 -1.779160986901294e+00 3.000000000000000e-01 8.965036540400221e-01 1.223621528106528e+00 8.924295259188577e+00 5.018149998009447e-09 1.235867134447878e+00 2.534083468324101e+05 1.013500714911605e+05 2.885408424240169e+02 7.061273608866685e+00 2.162216996555978e-02
-194 1.779160986895464e+00 3.000000000000000e-01 8.965036540386054e-01 1.224434600260024e+00 4.479797361202935e+00 6.240979655897632e-09 -2.419437813215028e+00 2.530997371002836e+05 1.012356606795100e+05 2.880237319788312e+02 -9.073377589901455e+00 1.222187639127362e-02
-195 -3.024549228140815e-01 3.000000000000000e-01 1.271810638079400e+00 1.223954304749333e+00 9.849029165467771e+00 8.612202153125104e-09 9.233807213835226e+00 2.532314842164342e+05 1.012628104552133e+05 2.882140298621293e+02 -5.244612154380717e+00 3.241021437011199e-02
-196 3.084909891748027e-01 3.000000000000000e-01 1.268420902912950e+00 1.223668512180781e+00 9.108841001115083e+00 1.143927463050426e-08 1.064677272108372e+00 2.530093585485979e+05 1.011899971276550e+05 2.880740538118760e+02 -1.551302670215273e+01 2.202647353397454e-02
-197 -1.906003421713626e-05 3.000000000000000e-01 1.200234358426896e+00 1.223041788780587e+00 1.022088491580133e+01 6.425922575453495e-09 6.470264994914349e+00 2.529161756518635e+05 1.011425412635666e+05 2.880865020512204e+02 -2.220543455555342e+01 2.906807706448221e-02
-198 -5.618007820408263e-01 3.000000000000000e-01 2.043746239937465e+00 1.223921332803368e+00 1.281268702253201e+01 9.061147425863896e-09 4.264715290713216e+00 2.534115096125087e+05 1.013348057296572e+05 2.884267125731130e+02 4.908437407584084e+00 3.240679360601596e-02
-199 -8.083224307437241e-01 3.000000000000000e-01 2.889383374999068e+00 1.223330644598326e+00 1.254801098691429e+01 3.308363962757774e-09 1.566657497050689e+00 2.533353875831421e+05 1.013080121427559e+05 2.884896813826304e+02 1.129903082203652e+00 3.035819102558194e-02
-200 5.647434910278286e-01 3.000000000000000e-01 2.014946179016490e+00 1.224336163526542e+00 1.567196205649914e+01 1.254929074726578e-08 1.479640890923964e+00 2.533299019781721e+05 1.012914817563030e+05 2.882057174081679e+02 -1.201275376816564e+00 3.777892511994817e-02
-201 8.221850434196895e-01 3.000000000000000e-01 2.852649226946881e+00 1.223865511324613e+00 1.589359120828567e+01 4.908164188817689e-09 1.132995408151602e+00 2.532912817227107e+05 1.012750228492707e+05 2.882697016726374e+02 -3.522373533961213e+00 3.825081460052316e-02
-202 -1.158518924678652e+00 3.000000000000000e-01 1.551501353485399e+00 1.223655841375004e+00 1.021422016716498e+01 7.223195640251549e-09 3.059935623821378e+00 2.533898588083895e+05 1.013373609291653e+05 2.884965656742121e+02 5.268781436369682e+00 2.559112397418225e-02
-203 1.158988950451789e+00 3.000000000000000e-01 1.552080641242281e+00 1.224526569721919e+00 1.117132818861910e+01 1.084627078915113e-08 -2.354730159658186e+00 2.532226024955179e+05 1.012677522273719e+05 2.880933958487354e+02 -4.547704502628100e+00 2.740063910722002e-02
-204 -2.216781681457610e+00 3.000000000000000e-01 1.838237906171512e+00 1.223470618035950e+00 1.027133285714975e+01 9.751825902256237e-10 7.714299422407684e-01 2.534062936878336e+05 1.013451741272419e+05 2.885624883716185e+02 6.370628577337776e+00 2.472213169513792e-02
-205 2.216781681455013e+00 3.000000000000000e-01 1.838237906163890e+00 1.224852511265535e+00 1.112031498571588e+01 -1.321485451306767e-09 -1.976584239167027e+00 2.532753527423245e+05 1.012893111129990e+05 2.880780481108026e+02 -1.507387815681948e+00 2.710089559268704e-02
-206 9.670971517162510e-01 3.000000000000000e-01 4.607420247048584e-01 1.224603197546549e+00 -7.405238170722468e-01 1.365748043638886e-08 -5.388238091919115e-01 2.530703532891747e+05 1.012280043396073e+05 2.879622983877502e+02 -1.015310398994684e+01 2.198330502157572e-03
-207 -9.670971517153459e-01 3.000000000000000e-01 4.607420247046419e-01 1.224348335120730e+00 6.280835987775534e+00 1.048786049764953e-08 1.918738239045335e+00 2.534180273062639e+05 1.013601654672379e+05 2.883982768150163e+02 8.484764805797230e+00 1.575585080836628e-02
-208 1.854114598533743e+00 3.000000000000000e-01 3.012715418354706e+00 1.224443019365754e+00 1.537143392464103e+01 -8.467022293532438e-10 -3.141849795394852e-01 2.533053825220807e+05 1.012835428506848e+05 2.881579793216372e+02 -2.320850277134363e+00 3.689795801888512e-02
-209 -1.854114598532094e+00 3.000000000000000e-01 3.012715418358399e+00 1.223177562004440e+00 1.142059764444878e+01 1.142815962223587e-09 5.438506209194209e-01 2.533432257868519e+05 1.013159155236859e+05 2.885482951927441e+02 2.244468154825014e+00 2.744941459057516e-02
-210 3.467727762006756e-01 3.000000000000000e-01 3.138478024891123e-01 1.224476376762928e+00 -1.108362800312081e+00 8.965531625461304e-09 9.893348574420331e-01 2.530073832577203e+05 1.012025927813828e+05 2.879198275639118e+02 -1.373673933397440e+01 3.566899501120525e-03
-211 -3.467727761998039e-01 3.000000000000000e-01 3.138478024875392e-01 1.225524406742974e+00 2.434357026821917e+00 7.296283498232319e-09 2.420917144737678e+00 2.534310260484284e+05 1.013704868454481e+05 2.881508551368908e+02 9.940325123124346e+00 8.232271001114500e-03
-212 2.714569979187768e-01 3.000000000000000e-01 7.206820098998908e-01 1.224066699667048e+00 -1.043463429422402e-01 9.106241780577387e-09 1.873870628545156e+00 2.529560026493118e+05 1.011818255552538e+05 2.879570878750912e+02 -1.666541316404260e+01 4.507067681978156e-03
-213 -2.714569979194104e-01 3.000000000000000e-01 7.206820098987166e-01 1.224881969572565e+00 2.239168986221774e+00 6.259522310156461e-09 6.113591255499747e+00 2.533161276565614e+05 1.013195295996850e+05 2.881570625229589e+02 2.754139005081474e+00 1.561972382751963e-02
-214 -2.889797296894188e-01 3.000000000000000e-01 9.267545678931778e-01 1.225102117099895e+00 4.087795407515322e+00 6.203951833608568e-09 8.727547343159936e+00 2.533945306843782e+05 1.013426494309769e+05 2.881710234507192e+02 6.014586232810669e+00 2.311613239648487e-02
-215 2.889797296888021e-01 3.000000000000000e-01 9.267545678937171e-01 1.222911668887668e+00 1.238583126058244e+00 8.999645771194799e-09 1.129694627691761e+00 2.527501138075753e+05 1.010995859153277e+05 2.879947912759050e+02 -2.826316241324654e+01 4.029395945184519e-03
-216 -2.096255493199925e-01 3.000000000000000e-01 1.496037590846734e+00 1.224438384633300e+00 1.247044962101562e+01 1.083277225241641e-08 7.922336456664456e+00 2.533644530686215e+05 1.013101280608340e+05 2.882347069172557e+02 1.428297959955684e+00 3.545223394739759e-02
-217 2.517633613169607e-01 3.000000000000000e-01 1.518247420292257e+00 1.223834798172732e+00 1.341832852955673e+01 1.255507411647670e-08 3.247594212637573e+00 2.531433946848268e+05 1.012262101391250e+05 2.881379918257769e+02 -1.040612901917670e+01 3.315032036996039e-02
-218 -6.660432832766596e-01 3.000000000000000e-01 1.081962603010036e+00 1.224355684217957e+00 7.751902524642739e+00 1.063020229632938e-08 5.677689461679074e+00 2.533944897262150e+05 1.013427139740846e+05 2.883468916022205e+02 6.023688349255979e+00 2.305435538819733e-02
-219 6.589236055220503e-01 3.000000000000000e-01 1.065642443794388e+00 1.224063977934532e+00 4.552762698305509e+00 1.437658840102771e-08 -1.077215942801887e+00 2.530229866419894e+05 1.012056183662147e+05 2.880254411423586e+02 -1.331005976382822e+01 1.123401688755159e-02
-220 -2.065827934826303e-01 3.000000000000000e-01 1.069425960577202e+00 1.224784675723022e+00 6.668159265031488e+00 5.692293393497718e-09 1.010624106338759e+01 2.533218708371922e+05 1.013048093586109e+05 2.881380846846332e+02 6.782341857166994e-01 2.905084302002239e-02
-221 2.065827934823721e-01 3.000000000000000e-01 1.069425960577464e+00 1.224356063931017e+00 3.844412992273053e+00 8.189604840277241e-09 8.274021816598346e-01 2.530940845768502e+05 1.012351077509368e+05 2.880406340353952e+02 -9.151353696685343e+00 9.440151038447088e-03
-222 -2.339028924130573e-01 3.000000000000000e-01 4.854032749601151e-01 1.225573798903895e+00 1.373451415075965e+00 5.733876483905320e-09 4.093935199183612e+00 2.534138240115653e+05 1.013624866749843e+05 2.881165023140043e+02 8.812110419441856e+00 1.035448042822686e-02
-223 2.339028924126051e-01 3.000000000000000e-01 4.854032749623373e-01 1.224566438324862e+00 -4.887605546085299e-01 8.616652870136802e-09 1.781265828902879e+00 2.530322980117577e+05 1.012123619797578e+05 2.879264434824253e+02 -1.235904953352760e+01 4.434242901126519e-03
-224 -6.934692988371788e-01 3.000000000000000e-01 7.488579429535888e-01 1.224562935330858e+00 5.957897323610212e+00 1.068335012132352e-08 4.175196371318664e+00 2.534045462315483e+05 1.013531739707690e+05 2.883278467692141e+02 7.498797175149466e+00 1.745310878826732e-02
-225 6.931604137473489e-01 3.000000000000000e-01 7.481498977313378e-01 1.224059284704104e+00 7.202425890341041e-01 1.389936858239602e-08 -2.715534646188509e-01 2.529702014777925e+05 1.011879837836047e+05 2.879763582630871e+02 -1.579695619733350e+01 1.848464196799306e-03
-226 -1.312362884067610e+00 3.000000000000000e-01 6.646874262097189e-01 1.223694603122501e+00 7.810289707205377e+00 8.955194081223973e-09 1.667189876438643e+00 2.533756612417907e+05 1.013398403030928e+05 2.884944855449257e+02 5.618432251137584e+00 1.916691034128460e-02
-227 1.312362884063586e+00 3.000000000000000e-01 6.646874262090433e-01 1.224645642478402e+00 1.664131870537559e+00 1.247833435783200e-08 -1.819589016818768e+00 2.531088699595136e+05 1.012425550044713e+05 2.879937086140951e+02 -8.101113457714645e+00 5.918471232425411e-03
-228 -1.380533872983328e-01 3.000000000000000e-01 3.181603062552175e+00 1.223450074584084e+00 1.392689575258163e+01 4.831238444439648e-09 1.554867237628014e+00 2.533147668285049e+05 1.012938047206196e+05 2.884210659718433e+02 -8.736820449031821e-01 3.364307319328166e-02
-229 7.419949146702542e-01 3.000000000000000e-01 2.620513753100355e-01 1.224116232941471e+00 -1.956940603307945e+00 1.116452958740291e-08 1.530185426698818e-01 2.529459269828584e+05 1.011777412726623e+05 2.879338126900024e+02 -1.724139435026491e+01 4.713933227711652e-03
-230 -7.419949146691938e-01 3.000000000000000e-01 2.620513753103896e-01 1.225088366894153e+00 5.004263359043365e+00 9.227435245604385e-09 1.095017520157300e+00 2.534926255394234e+05 1.013927661631499e+05 2.883167679483280e+02 1.308223990268246e+01 1.228414394431984e-02
-231 2.375341278589752e+00 3.000000000000000e-01 5.856470294858179e-01 1.224421467614615e+00 3.109231535210962e+00 1.995376564309546e-09 -1.350802404586876e+00 2.530809759062615e+05 1.012305132330717e+05 2.880121761408762e+02 -9.799290216942778e+00 8.137900483573388e-03
-232 -2.375341278594772e+00 3.000000000000000e-01 5.856470294875045e-01 1.223663251334028e+00 8.963591509775631e+00 2.333528866472123e-09 4.253140949313823e-01 2.534362454677968e+05 1.013613365816287e+05 2.885630743578160e+02 8.649919846100250e+00 2.153472124796962e-02
-233 2.370934994068257e+00 3.000000000000000e-01 2.530901175131019e+00 1.224947072364782e+00 1.391069059609266e+01 -2.281005325122558e-09 -9.533153888077018e-01 2.533354431748836e+05 1.013024344906160e+05 2.880931310796873e+02 3.433211981318727e-01 3.345288042371867e-02
-234 -2.370934994068034e+00 3.000000000000000e-01 2.530901175137551e+00 1.223429922906519e+00 1.090553836430811e+01 7.059495825838273e-10 4.540008637019808e-01 2.534030231122003e+05 1.013417333629241e+05 2.885622895733801e+02 5.885398804702794e+00 2.619843729824351e-02
-235 -1.790781052807056e-01 3.000000000000000e-01 2.118264311918558e+00 1.223638627446884e+00 1.450435713928916e+01 1.146705814552683e-08 4.708079003041341e+00 2.533122998664837e+05 1.012869116034917e+05 2.883569983681900e+02 -1.845775843792691e+00 3.660865630714936e-02
-236 -7.921348971844293e-01 3.000000000000000e-01 1.723545051111688e+00 1.223530799362519e+00 1.116245451143760e+01 9.801573798827419e-09 4.517234393803631e+00 2.533231383826111e+05 1.013055525092150e+05 2.884354849502258e+02 7.830361324283193e-01 2.890710414649283e-02
-237 7.983255105839553e-01 3.000000000000000e-01 1.699241333964839e+00 1.223720865297789e+00 1.338013307911549e+01 1.331757863857607e-08 -9.470713012806729e-01 2.531049667865378e+05 1.012125805141707e+05 2.881260185092256e+02 -1.232823097296232e+01 3.221240806415528e-02
-238 -4.642644325923871e-01 3.000000000000000e-01 2.484420071406212e+00 1.223479033951615e+00 1.344219787137159e+01 6.971493562168169e-09 3.076475532012551e+00 2.533321164452271e+05 1.013017618794511e+05 2.884368955839712e+02 2.484669935239218e-01 3.310440721404474e-02
-239 -1.296959501136076e+00 3.000000000000000e-01 1.140605243476817e+00 1.223647829654314e+00 8.968983868419867e+00 8.163725247419680e-09 2.468125015471182e+00 2.533823260301206e+05 1.013387867490388e+05 2.885025137611031e+02 5.469856020144591e+00 2.232616264142730e-02
-240 1.297037838762715e+00 3.000000000000000e-01 1.140701791435802e+00 1.224659062580748e+00 6.434502274715497e+00 1.139984179347912e-08 -2.678401508112339e+00 2.531713426182409e+05 1.012606039570762e+05 2.880418940452795e+02 -5.555780979242253e+00 1.672714895639591e-02
-241 -4.081579652100921e-01 3.000000000000000e-01 1.105756673356268e+00 1.224527743574182e+00 7.464364301690493e+00 8.519393326190773e-09 8.396141829638010e+00 2.533517162008425e+05 1.013200725036077e+05 2.882419638188258e+02 2.830701397224670e+00 2.695591815680643e-02
-242 4.130074186115749e-01 3.000000000000000e-01 1.099646911654121e+00 1.223865905394093e+00 4.725620981523283e+00 1.171514784890254e-08 -1.090344804732077e-01 2.529898243289721e+05 1.011922784521340e+05 2.880340848878100e+02 -1.519130557974590e+01 1.135193337955645e-02
-243 -3.772008574027238e-01 3.000000000000000e-01 1.757108739594634e+00 1.223761985976438e+00 1.296735982028171e+01 1.187314708174100e-08 6.068411820015125e+00 2.533158988366167e+05 1.012928598762041e+05 2.883448638238892e+02 -1.006927625991698e+00 3.436780197593409e-02
-244 -4.919077155844299e-01 3.000000000000000e-01 7.088942783330604e-01 1.225548251886307e+00 4.505913304167621e+00 8.632883963420477e-09 4.917879423152655e+00 2.535307087926420e+05 1.014050232900267e+05 2.882434183887595e+02 1.481078691674954e+01 1.599065857401499e-02
-245 4.918304943116507e-01 3.000000000000000e-01 7.087172670283998e-01 1.224495166956693e+00 -4.060538032729105e-01 1.177468161168702e-08 7.414165227595441e-01 2.530430790722735e+05 1.012171149149899e+05 2.879567239738491e+02 -1.168877238895588e+01 2.029342422104655e-03
-246 -3.812006875457408e-06 3.000000000000000e-01 1.075683673435016e+00 1.227303890548594e+00 7.087819502925473e+00 4.111483268067673e-09 4.854507317107696e+00 2.537465160779011e+05 1.014865795114764e+05 2.880625824211775e+02 2.631215787284939e+01 2.057282264063008e-02
-247 1.951707213103545e-01 3.000000000000000e-01 2.080383973855081e+00 1.223795891266173e+00 1.558481693333718e+01 1.269452499197141e-08 3.713218885437903e+00 2.532900424062987e+05 1.012740696876236e+05 2.882833876997819e+02 -3.656792042927177e+00 3.846127961368476e-02
-248 -1.661418383658756e+00 3.000000000000000e-01 1.556854534039652e+00 1.223499202337878e+00 1.001131830325086e+01 4.008862196048101e-09 1.679226528559900e+00 2.533891646511094e+05 1.013388213384847e+05 2.885376587376502e+02 5.474733956381896e+00 2.436477499803837e-02
-249 1.661832453980385e+00 3.000000000000000e-01 1.557364858964508e+00 1.223784548870009e+00 9.878683730158627e+00 3.996074442296121e-09 -2.397572780050544e+00 2.530495564543372e+05 1.012029345196047e+05 2.880835667226914e+02 -1.368854610002516e+01 2.441261715853740e-02
-250 5.290562426421479e-01 3.000000000000000e-01 3.385983609739860e+00 1.223526745484450e+00 1.514732263491179e+01 3.522894954807566e-09 8.152588824568864e-01 2.532750989436778e+05 1.012724260098232e+05 2.883421230848602e+02 -3.888589786604172e+00 3.642064573756729e-02
-251 -1.371705261972805e-01 3.000000000000000e-01 1.258416746755928e+00 1.224516442086541e+00 1.086146429513379e+01 7.588371202175385e-09 8.951848784780047e+00 2.532900877713719e+05 1.012836783354600e+05 2.881410866404595e+02 -2.301743694823756e+00 3.377799393127733e-02
-252 1.451397844830034e-01 3.000000000000000e-01 1.261553429135801e+00 1.223843144740066e+00 1.030381605460206e+01 9.060103596434095e-09 3.143120455374575e+00 2.530690441186644e+05 1.012086531532031e+05 2.880860515341038e+02 -1.288208247030341e+01 2.586918784533631e-02
-253 -1.670022720633292e+00 3.000000000000000e-01 3.934843812824604e-01 1.223620404216890e+00 8.109840990669611e+00 5.890353398535566e-09 5.952527634963319e-01 2.533944876009086e+05 1.013469871384163e+05 2.885323263726572e+02 6.626306362473271e+00 1.951579561094052e-02
-254 1.670022720624052e+00 3.000000000000000e-01 3.934843812811255e-01 1.224677047190551e+00 7.529160662569608e-01 8.093055300831620e-09 -9.949315197655711e-01 2.531056664935419e+05 1.012420123636437e+05 2.879847799646088e+02 -8.177638747179627e+00 2.994726883102374e-03
-255 1.262577532593635e+00 3.000000000000000e-01 3.364522470067870e+00 1.224046277543967e+00 1.578759167693170e+01 1.220636871098941e-09 2.828569661363707e-01 2.533059188300178e+05 1.012816291933356e+05 2.882459317751009e+02 -2.590721571626436e+00 3.790157889917034e-02
-256 -1.262577532594160e+00 3.000000000000000e-01 3.364522470071912e+00 1.223182758186593e+00 1.210989213922545e+01 2.190355683086270e-09 5.923814090912525e-01 2.533260800085636e+05 1.013063962814740e+05 2.885199586755757e+02 9.020281305912485e-01 2.910925808939660e-02
-257 -2.259570044434444e+00 3.000000000000000e-01 1.141342455190163e+00 1.223375227252896e+00 9.608300786066692e+00 1.864507964837270e-09 7.669337594425382e-01 2.533820373435868e+05 1.013376261990465e+05 2.885634955148955e+02 5.306190811797411e+00 2.313643663755366e-02
-258 2.259570044423067e+00 3.000000000000000e-01 1.141342455181824e+00 1.225610333582390e+00 7.331550900412565e+00 -3.555443657093759e-10 -2.295465308367796e+00 2.533759210297865e+05 1.013407371615946e+05 2.880460939580653e+02 5.744910674745119e+00 1.842342157747611e-02
-259 4.855341639785172e-01 3.000000000000000e-01 2.466426775981777e+00 1.224263605421364e+00 1.577588473011841e+01 9.840017800153940e-09 2.208635007904709e+00 2.533838173825012e+05 1.013120723828421e+05 2.882813886179964e+02 1.702493702178382e+00 3.822756125812672e-02
-260 -1.276009205397341e+00 3.000000000000000e-01 3.037827664393642e-01 1.224181183016283e+00 7.149953131436344e+00 8.248940734105030e-09 6.581982364693265e-01 2.534604543680180e+05 1.013757589654465e+05 2.884820292437941e+02 1.068381969348842e+01 1.722589116654681e-02
-261 1.276009205392552e+00 3.000000000000000e-01 3.037827664390054e-01 1.224591741287846e+00 -1.083393516530873e+00 1.103275464545389e-08 -6.447577428669498e-01 2.530681574038738e+05 1.012270033723321e+05 2.879621448544758e+02 -1.029426423182763e+01 3.026328854082359e-03
-262 2.135573730685918e-01 3.000000000000000e-01 1.580206643002382e-01 1.224613228937877e+00 -7.116074537082007e-01 5.837787147272627e-09 6.506868571942728e-01 2.530281542016746e+05 1.012111098321461e+05 2.879118803072799e+02 -1.253563218923328e+01 2.314793092228321e-03
-263 3.890522885319399e-01 3.000000000000000e-01 1.526836842918348e-01 1.224740580788777e+00 -1.442143604879722e+00 6.789248094070251e-09 2.737261685693479e-01 2.530581947925579e+05 1.012229260540692e+05 2.879155521668422e+02 -1.086926328173057e+01 3.523451621311099e-03
-264 5.300891290855102e-01 3.000000000000000e-01 2.792970282796143e-01 1.224826238520110e+00 -1.518834717823189e+00 9.987785528754811e-09 4.521533338339750e-01 2.530829588171674e+05 1.012327734602863e+05 2.879234246257824e+02 -9.480544311615464e+00 3.803536647475275e-03
-265 -2.135573730679655e-01 3.000000000000000e-01 1.580206642994352e-01 1.225574792583729e+00 1.477527512596594e+00 5.320755117686713e-09 1.349010771603916e+00 2.533961316019835e+05 1.013577994097320e+05 2.881029454666606e+02 8.151094307156667e+00 4.797619616045060e-03
-266 -3.890522885318832e-01 3.000000000000000e-01 1.526836842909433e-01 1.225804487582463e+00 2.914333493955710e+00 7.127802796369385e-09 7.801372960333826e-01 2.535056280921764e+05 1.014007661788524e+05 2.881710672130059e+02 1.421043278133025e+01 7.232227458707051e-03
-267 -5.300891290842963e-01 3.000000000000000e-01 2.792970282778868e-01 1.224930330231313e+00 3.824266948724480e+00 8.509144396006159e-09 1.494990338280209e+00 2.533791143018988e+05 1.013488929088827e+05 2.882291931922520e+02 6.895065418514232e+00 9.849172560753273e-03
-268 -7.875523834420067e-02 3.000000000000000e-01 1.120752147839008e+00 1.223592701311180e+00 7.820450323151918e+00 4.382351456162675e-09 9.506185094736958e+00 2.530306252030936e+05 1.011874825261270e+05 2.880847430199857e+02 -1.586764544817762e+01 2.956644831356115e-02
-269 8.033994118485660e-02 3.000000000000000e-01 1.121379484315036e+00 1.224276596419039e+00 7.089866160936032e+00 5.930943145584599e-09 1.569687966948280e+00 2.531086798790633e+05 1.012348578651275e+05 2.880586196493151e+02 -9.186593551326235e+00 1.743253556083164e-02
-270 -1.773494387528787e+00 3.000000000000000e-01 2.251338641411685e+00 1.223250770675654e+00 1.090056693572192e+01 1.515477791224196e-09 1.121745012640096e+00 2.533525641797285e+05 1.013213926294651e+05 2.885466241527782e+02 3.016870605705703e+00 2.630656913231798e-02
-271 1.773729438481018e+00 3.000000000000000e-01 2.251628332197096e+00 1.224699321549158e+00 1.374274966196731e+01 3.559877257659501e-10 -1.364654055374948e+00 2.533148931717710e+05 1.012948107749353e+05 2.881297255362076e+02 -7.318044090647137e-01 3.313843295596714e-02
-272 5.131609952661074e-01 3.000000000000000e-01 1.722883911813639e+00 1.224931076744892e+00 1.458181598837255e+01 1.356264181886855e-08 1.355211951192612e+00 2.533914554084079e+05 1.013215653430664e+05 2.881512998891888e+02 3.041227339782138e+00 3.513244642742497e-02
-273 1.562483280349060e-01 3.000000000000000e-01 9.024089340530100e-01 1.224968806646067e+00 -5.386328634858836e-01 6.854951069767616e-09 2.808620071065820e+00 2.531714463191437e+05 1.012672432329102e+05 2.879879411807651e+02 -4.619484852597617e+00 6.862384704217781e-03
-274 -1.562483280352914e-01 3.000000000000000e-01 9.024089340525773e-01 1.225667425097166e+00 2.159649959518688e+00 3.831743538379169e-09 9.218549851375020e+00 2.534547899044616e+05 1.013672878909924e+05 2.881081398042667e+02 9.489196304108440e+00 2.270207727113891e-02
-275 -2.398406843342383e+00 3.000000000000000e-01 3.398406843344410e+00 1.223264152186528e+00 1.139765760423133e+01 8.860830988847494e-10 1.429988399889444e-01 2.533707730829367e+05 1.013270665527120e+05 2.885596259096899e+02 3.817029010298840e+00 2.736294941522355e-02
-276 2.398406843344079e+00 3.000000000000000e-01 3.398406843341552e+00 1.224814473800336e+00 1.544644406536279e+01 -1.298735225116038e-09 -1.755587523583038e-01 2.533395483275104e+05 1.012968544983304e+05 2.881084494666977e+02 -4.435907022420196e-01 3.706460807990056e-02
-277 -9.026427775494201e-01 3.000000000000000e-01 1.305047070269513e+00 1.223810619826666e+00 9.317122467533215e+00 1.048399107287583e-08 4.350250868114854e+00 2.533674473665217e+05 1.013296995649825e+05 2.884382704562574e+02 4.188346493091414e+00 2.467838328334460e-02
-278 9.076093826908616e-01 3.000000000000000e-01 1.295564284189789e+00 1.223992801819190e+00 8.198213867502096e+00 1.449920271631570e-08 -2.121028594355656e+00 2.530624255645908e+05 1.012132529227919e+05 2.880639188193553e+02 -1.223340533184518e+01 2.033368652409044e-02
-279 1.368927313237185e+00 3.000000000000000e-01 2.720791131917900e+00 1.224153104741666e+00 1.562503615213054e+01 1.844473633722040e-09 -5.954085489547954e-02 2.532834829948400e+05 1.012735051644991e+05 2.881976588048091e+02 -3.736403257770806e+00 3.750544961608832e-02
-280 -1.365637754737275e+00 3.000000000000000e-01 2.727500735615763e+00 1.223529537264136e+00 1.159185082692082e+01 1.611779867990916e-09 1.197782766044148e+00 2.534018748508446e+05 1.013385509357348e+05 2.885297351462694e+02 5.436600724129958e+00 2.797051031210293e-02
-281 -6.417906701235564e-01 3.000000000000000e-01 3.487101781524630e+00 1.223101522438174e+00 1.283243467990999e+01 3.267063485938912e-09 5.323642714425935e-01 2.532805134611253e+05 1.012852321874578e+05 2.884788423393517e+02 -2.082613530142289e+00 3.083998317191033e-02
-282 3.460139993677798e-01 3.000000000000000e-01 2.888128468202591e+00 1.223825838750480e+00 1.526391304670462e+01 6.400057816521802e-09 2.126786942971214e+00 2.533451356335373e+05 1.012992398638706e+05 2.883479801261245e+02 -1.071973105898712e-01 3.699255014356649e-02
-283 1.788466083363745e-01 3.000000000000000e-01 3.114543483508369e-01 1.224454524559366e+00 -3.373364487004447e-01 6.664368755155355e-09 1.407246518538883e+00 2.529977697280481e+05 1.011987658387213e+05 2.879140781318391e+02 -1.427642945687471e+01 3.474399544493145e-03
-284 -1.788466083361653e-01 3.000000000000000e-01 3.114543483491244e-01 1.225419916745499e+00 8.086640666601806e-01 4.580644488361443e-09 2.878300268441159e+00 2.533471291181294e+05 1.013373927922281e+05 2.880813458133853e+02 5.273274887622212e+00 7.170380274075710e-03
-285 2.711768521854932e-01 3.000000000000000e-01 1.797395744097217e+00 1.223027344529501e+00 1.541375522531589e+01 1.316136570431226e-08 3.570953881564504e+00 2.530606640322486e+05 1.011833285785984e+05 2.882060811924023e+02 -1.645345105084641e+01 3.801234757679275e-02
diff --git a/FSI/flap_perp/SU2-CalculiX/README.md b/FSI/flap_perp/SU2-CalculiX/README.md
deleted file mode 100644
index 6e2b9135a..000000000
--- a/FSI/flap_perp/SU2-CalculiX/README.md
+++ /dev/null
@@ -1,3 +0,0 @@
-# Tutorial for a coupled simulation with SU2 and CalculiX
-
-The files in this folder can be used to run the tutorial test case described on this [Wiki page](https://github.com/precice/precice/wiki/FSI-tutorial). For running the case either follow the instructions given there or execute the script `runTutorial_serial.sh` or `runTutorial_parallel.sh` (with SU2 being executed with one or several processes, respectively).
diff --git a/FSI/flap_perp/SU2-CalculiX/Solid/all.msh b/FSI/flap_perp/SU2-CalculiX/Solid/all.msh
deleted file mode 100644
index 3fe596cb7..000000000
--- a/FSI/flap_perp/SU2-CalculiX/Solid/all.msh
+++ /dev/null
@@ -1,80 +0,0 @@
-*NODE, NSET=Nall
- 1,5.000000000000e-02,0.000000000000e+00,1.000000000000e+00
- 2,-5.000000000000e-02,0.000000000000e+00,1.000000000000e+00
- 3,-5.000000000000e-02,3.000000000000e-01,1.000000000000e+00
- 4,5.000000000000e-02,3.000000000000e-01,1.000000000000e+00
- 5,5.000000000000e-02,0.000000000000e+00,8.000000000000e-01
- 6,-5.000000000000e-02,0.000000000000e+00,8.000000000000e-01
- 7,-5.000000000000e-02,3.000000000000e-01,8.000000000000e-01
- 8,5.000000000000e-02,3.000000000000e-01,8.000000000000e-01
- 9,0.000000000000e+00,0.000000000000e+00,1.000000000000e+00
- 10,-5.000000000000e-02,1.500000000000e-01,1.000000000000e+00
- 11,0.000000000000e+00,3.000000000000e-01,1.000000000000e+00
- 12,5.000000000000e-02,1.500000000000e-01,1.000000000000e+00
- 13,5.000000000000e-02,0.000000000000e+00,9.000000000000e-01
- 14,-5.000000000000e-02,0.000000000000e+00,9.000000000000e-01
- 15,-5.000000000000e-02,3.000000000000e-01,9.000000000000e-01
- 16,5.000000000000e-02,3.000000000000e-01,9.000000000000e-01
- 17,8.673617379884e-19,0.000000000000e+00,8.000000000000e-01
- 18,-5.000000000000e-02,1.500000000000e-01,8.000000000000e-01
- 19,8.673617379884e-19,3.000000000000e-01,8.000000000000e-01
- 20,5.000000000000e-02,1.500000000000e-01,8.000000000000e-01
- 21,5.000000000000e-02,0.000000000000e+00,6.000000000000e-01
- 22,-5.000000000000e-02,0.000000000000e+00,6.000000000000e-01
- 23,-5.000000000000e-02,3.000000000000e-01,6.000000000000e-01
- 24,5.000000000000e-02,3.000000000000e-01,6.000000000000e-01
- 25,5.000000000000e-02,0.000000000000e+00,7.000000000000e-01
- 26,-5.000000000000e-02,0.000000000000e+00,7.000000000000e-01
- 27,-5.000000000000e-02,3.000000000000e-01,7.000000000000e-01
- 28,5.000000000000e-02,3.000000000000e-01,7.000000000000e-01
- 29,1.734723475977e-18,0.000000000000e+00,6.000000000000e-01
- 30,-5.000000000000e-02,1.500000000000e-01,6.000000000000e-01
- 31,1.734723475977e-18,3.000000000000e-01,6.000000000000e-01
- 32,5.000000000000e-02,1.500000000000e-01,6.000000000000e-01
- 33,5.000000000000e-02,0.000000000000e+00,4.000000000000e-01
- 34,-5.000000000000e-02,0.000000000000e+00,4.000000000000e-01
- 35,-5.000000000000e-02,3.000000000000e-01,4.000000000000e-01
- 36,5.000000000000e-02,3.000000000000e-01,4.000000000000e-01
- 37,5.000000000000e-02,0.000000000000e+00,5.000000000000e-01
- 38,-5.000000000000e-02,0.000000000000e+00,5.000000000000e-01
- 39,-5.000000000000e-02,3.000000000000e-01,5.000000000000e-01
- 40,5.000000000000e-02,3.000000000000e-01,5.000000000000e-01
- 41,0.000000000000e+00,0.000000000000e+00,4.000000000000e-01
- 42,-5.000000000000e-02,1.500000000000e-01,4.000000000000e-01
- 43,0.000000000000e+00,3.000000000000e-01,4.000000000000e-01
- 44,5.000000000000e-02,1.500000000000e-01,4.000000000000e-01
- 45,5.000000000000e-02,0.000000000000e+00,2.000000000000e-01
- 46,-5.000000000000e-02,0.000000000000e+00,2.000000000000e-01
- 47,-5.000000000000e-02,3.000000000000e-01,2.000000000000e-01
- 48,5.000000000000e-02,3.000000000000e-01,2.000000000000e-01
- 49,5.000000000000e-02,0.000000000000e+00,3.000000000000e-01
- 50,-5.000000000000e-02,0.000000000000e+00,3.000000000000e-01
- 51,-5.000000000000e-02,3.000000000000e-01,3.000000000000e-01
- 52,5.000000000000e-02,3.000000000000e-01,3.000000000000e-01
- 53,0.000000000000e+00,0.000000000000e+00,2.000000000000e-01
- 54,-5.000000000000e-02,1.500000000000e-01,2.000000000000e-01
- 55,0.000000000000e+00,3.000000000000e-01,2.000000000000e-01
- 56,5.000000000000e-02,1.500000000000e-01,2.000000000000e-01
- 57,5.000000000000e-02,0.000000000000e+00,0.000000000000e+00
- 58,-5.000000000000e-02,0.000000000000e+00,0.000000000000e+00
- 59,-5.000000000000e-02,3.000000000000e-01,0.000000000000e+00
- 60,5.000000000000e-02,3.000000000000e-01,0.000000000000e+00
- 61,5.000000000000e-02,0.000000000000e+00,1.000000000000e-01
- 62,-5.000000000000e-02,0.000000000000e+00,1.000000000000e-01
- 63,-5.000000000000e-02,3.000000000000e-01,1.000000000000e-01
- 64,5.000000000000e-02,3.000000000000e-01,1.000000000000e-01
- 65,0.000000000000e+00,0.000000000000e+00,0.000000000000e+00
- 66,-5.000000000000e-02,1.500000000000e-01,0.000000000000e+00
- 67,0.000000000000e+00,3.000000000000e-01,0.000000000000e+00
- 68,5.000000000000e-02,1.500000000000e-01,0.000000000000e+00
-*ELEMENT, TYPE=C3D20, ELSET=Eall
- 1, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10,
- 11, 12, 17, 18, 19, 20, 13, 14, 15, 16
- 2, 5, 6, 7, 8, 21, 22, 23, 24, 17, 18,
- 19, 20, 29, 30, 31, 32, 25, 26, 27, 28
- 3, 21, 22, 23, 24, 33, 34, 35, 36, 29, 30,
- 31, 32, 41, 42, 43, 44, 37, 38, 39, 40
- 4, 33, 34, 35, 36, 45, 46, 47, 48, 41, 42,
- 43, 44, 53, 54, 55, 56, 49, 50, 51, 52
- 5, 45, 46, 47, 48, 57, 58, 59, 60, 53, 54,
- 55, 56, 65, 66, 67, 68, 61, 62, 63, 64
diff --git a/FSI/flap_perp/SU2-CalculiX/Solid/fix1_beam.nam b/FSI/flap_perp/SU2-CalculiX/Solid/fix1_beam.nam
deleted file mode 100644
index 2e0376070..000000000
--- a/FSI/flap_perp/SU2-CalculiX/Solid/fix1_beam.nam
+++ /dev/null
@@ -1,10 +0,0 @@
-** Names based on fix1
-*NSET,NSET=Nfix1
-57,
-58,
-59,
-60,
-65,
-66,
-67,
-68,
diff --git a/FSI/flap_perp/SU2-CalculiX/Solid/interface_beam.nam b/FSI/flap_perp/SU2-CalculiX/Solid/interface_beam.nam
deleted file mode 100644
index 5bc822134..000000000
--- a/FSI/flap_perp/SU2-CalculiX/Solid/interface_beam.nam
+++ /dev/null
@@ -1,60 +0,0 @@
-** Names based on interface
-*NSET,NSET=Nsurface
-1,
-2,
-3,
-4,
-5,
-6,
-7,
-8,
-9,
-10,
-11,
-12,
-13,
-14,
-15,
-16,
-18,
-20,
-21,
-22,
-23,
-24,
-25,
-26,
-27,
-28,
-30,
-32,
-33,
-34,
-35,
-36,
-37,
-38,
-39,
-40,
-42,
-44,
-45,
-46,
-47,
-48,
-49,
-50,
-51,
-52,
-54,
-56,
-57,
-58,
-59,
-60,
-61,
-62,
-63,
-64,
-66,
-68,
diff --git a/FSI/flap_perp/SU2-CalculiX/config.yml b/FSI/flap_perp/SU2-CalculiX/config.yml
deleted file mode 100644
index a6871569d..000000000
--- a/FSI/flap_perp/SU2-CalculiX/config.yml
+++ /dev/null
@@ -1,10 +0,0 @@
-participants:
-
- Calculix:
- interfaces:
- - nodes-mesh: Calculix_Mesh
- patch: surface
- read-data: [Forces0]
- write-data: [DisplacementDeltas0]
-
-precice-config-file: ./precice-config.xml
diff --git a/FSI/flap_perp/SU2-CalculiX/precice-config.xml b/FSI/flap_perp/SU2-CalculiX/precice-config.xml
deleted file mode 100644
index f92b97a05..000000000
--- a/FSI/flap_perp/SU2-CalculiX/precice-config.xml
+++ /dev/null
@@ -1,82 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/flap_perp/SU2-CalculiX/runTutorial_parallel.sh b/FSI/flap_perp/SU2-CalculiX/runTutorial_parallel.sh
deleted file mode 100755
index 2d329f9a2..000000000
--- a/FSI/flap_perp/SU2-CalculiX/runTutorial_parallel.sh
+++ /dev/null
@@ -1,48 +0,0 @@
-#! /bin/bash
-
-
-tmux has-session -t PreciceSU2-Calculix-newtonParallel 2>/dev/null
-if [ "$?" -eq 1 ] ; then
- tmux new-session -d -s 'PreciceSU2-Calculix-newtonParallel'
- tmux split-window -v
-fi
-
-
-session=PreciceSU2-Calculix-newtonParallel
-window=${session}:0
-pane_su2=${window}.0
-pane_Calculix=${window}.1
-tmux send-keys -t "$pane_su2" C-z '( time mpirun -n 2 SU2_CFD Fluid/euler_config_coupled.cfg ) 2>&1 | tee Su2.log' Enter
-tmux select-pane -t "$pane_su2"
-tmux select-window -t "$window"
-tmux send-keys -t "$pane_Calculix" C-z '( time ccx_preCICE -i Solid/flap -precice-participant Calculix ) 2>&1 | tee Calculix.log' Enter
-tmux select-pane -t "$pane_Calculix"
-tmux select-window -t "$window"
-tmux attach-session -t "$session"
-
-tmux detach -s "$session"
-
-SU2_SOL Fluid/euler_config_coupled_mergeSolution.cfg
-
-rm -rf Output
-mkdir Output
-cp flow*.vtk Output
-cp euler_config_coupled.cfg Output
-cp flap.inp Output
-cp Calculix.log Output
-cp Su2.log Output
-cp precice-config.xml Output
-cp point1.watchpoint.txt Output
-cp plotDisplacement.sh Output
-# clean everything
-rm -f *log
-rm -f *vtk
-rm -f *txt
-rm -f *csv
-rm -f *out
-rm -f restart_flow*
-rm -f forces*
-rm -f flap.[^i]*
-
- echo " Copying of results was successfull! Let's hope that simulation went well as well. Results are in the output
- folder"
diff --git a/FSI/flap_perp/SU2-CalculiX/runTutorial_serial.sh b/FSI/flap_perp/SU2-CalculiX/runTutorial_serial.sh
deleted file mode 100755
index de486e22d..000000000
--- a/FSI/flap_perp/SU2-CalculiX/runTutorial_serial.sh
+++ /dev/null
@@ -1,46 +0,0 @@
-#! /bin/bash
-
-
-tmux has-session -t PreciceSU2-Calculix-newtonParallel 2>/dev/null
-if [ "$?" -eq 1 ] ; then
- tmux new-session -d -s 'PreciceSU2-Calculix-newtonParallel'
- tmux split-window -v
-fi
-
-
-session=PreciceSU2-Calculix-newtonParallel
-window=${session}:0
-pane_su2=${window}.0
-pane_Calculix=${window}.1
-tmux send-keys -t "$pane_su2" C-z '( time SU2_CFD Fluid/euler_config_coupled.cfg ) 2>&1 | tee Su2.log' Enter
-tmux select-pane -t "$pane_su2"
-tmux select-window -t "$window"
-tmux send-keys -t "$pane_Calculix" C-z '( time ccx_preCICE -i Solid/flap -precice-participant Calculix ) 2>&1 | tee Calculix.log' Enter
-tmux select-pane -t "$pane_Calculix"
-tmux select-window -t "$window"
-tmux attach-session -t "$session"
-
-tmux detach -s "$session"
-
-rm -rf Output
-mkdir Output
-cp flow*.vtk Output
-cp euler_config_coupled.cfg Output
-cp flap.inp Output
-cp Calculix.log Output
-cp Su2.log Output
-cp precice-config.xml Output
-cp point1.watchpoint.txt Output
-cp plotDisplacement.sh Output
-# clean everything
-rm -f *log
-rm -f *vtk
-rm -f *txt
-rm -f *csv
-rm -f *out
-rm -f restart_flow*
-rm -f forces*
-rm -f flap.[^i]*
-
- echo " Copying of results was successfull! Let's hope that simulation went well as well. Results are in the output
- folder"
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/.gitignore b/FSI/flap_perp_2D/OpenFOAM-FEniCS/.gitignore
deleted file mode 100644
index 301e1e7fd..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/.gitignore
+++ /dev/null
@@ -1,19 +0,0 @@
-!Fluid
-Fluid/*
-!Fluid/0
-!Fluid/0.orig
-!Fluid/constant
-Fluid/constant/polyMesh
-!Fluid/system
-!Fluid/Fluid.foam
-!Fluid/precice-adapter-config.yml
-!Solid
-Solid/*
-!Solid/perp-flap.py
-!Solid/precice-adapter-config-fsi-s.json
-*.log
-elastodynamics-results.h5
-elastodynamics-results.xdmf
-preCICE-output
-precice-fenics-events.json
-precice-Fluid-events.json
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Allclean b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Allclean
deleted file mode 100755
index 335e4274b..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Allclean
+++ /dev/null
@@ -1,64 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- rm -rfv 0
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_potentialFoam.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid
-Participant2="Solid"
-cd ${Participant2}
-cd FSI-S
- # Clean the case
- rm -fv *.vtu
- rm -fv *.pvd
- rm -fv *.log
-cd ..
-cd ..
-# Remove the log files
-rm -fv spooles.out
-rm -fv ${Participant2}.log
-
-# Remove the precice-events-files
-rm -fv precice-fenics-events.json
-rm -fv precice-Fluid-events.json
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-postProcessingInfo.log
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/p b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/p
deleted file mode 100644
index a558fafcf..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/p
+++ /dev/null
@@ -1,48 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 2 -2 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- inlet
- {
- type zeroGradient;
- }
-
- outlet
- {
- type fixedValue;
- value uniform 0;
- }
-
- flap
- {
- type zeroGradient;
- }
-
- upperWall
- {
- type zeroGradient;
- }
-
- lowerWall
- {
- type zeroGradient;
- }
-
- frontAndBack
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/phi b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/phi
deleted file mode 100644
index 06c61d9c4..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/phi
+++ /dev/null
@@ -1,49 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class surfaceScalarField;
- location "0";
- object phi;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 3 -1 0 0 0 0];
-
-internalField uniform 0;
-boundaryField
-{
- inlet
- {
- type calculated;
- value $internalField;
- }
- outlet
- {
- type calculated;
- value $internalField;
- }
- flap
- {
- type calculated;
- value uniform 0;
- }
- upperWall
- {
- type calculated;
- value uniform 0;
- }
- lowerWall
- {
- type calculated;
- value uniform 0;
- }
- frontAndBack
- {
- type empty;
- value nonuniform 0;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/pointDisplacement b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/pointDisplacement
deleted file mode 100644
index c107f3b65..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/0.orig/pointDisplacement
+++ /dev/null
@@ -1,50 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class pointVectorField;
- object pointDisplacement;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 0 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- flap
- {
- type fixedValue;
- value $internalField;
- }
-
- upperWall
- {
- type slip;
- }
-
- lowerWall
- {
- type slip;
- }
-
- frontAndBack
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/Fluid.foam b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/constant/dynamicMeshDict b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/constant/dynamicMeshDict
deleted file mode 100644
index d323bc059..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/constant/dynamicMeshDict
+++ /dev/null
@@ -1,22 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object dynamicMeshDict;
-}
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dynamicFvMesh dynamicMotionSolverFvMesh;
-
-motionSolverLibs ("libfvMotionSolvers.so");
-
-solver displacementLaplacian;
-
-displacementLaplacianCoeffs {
-
- diffusivity quadratic inverseDistance (flap);
-
-}
\ No newline at end of file
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/blockMeshDict b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/blockMeshDict
deleted file mode 100644
index 7ab73aa3c..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/blockMeshDict
+++ /dev/null
@@ -1,154 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-scale 1.;
-
-x0 -3.;
-x1 -0.05;
-x2 0.05;
-x3 3.;
-
-z0 0.;
-z1 1.;
-z2 4.;
-
-w_f 0.5;
-w_b -0.5;
-
-vertices
-(
- ($x0 $w_f $z0) // 0
- ($x1 $w_f $z0) // 1
- ($x2 $w_f $z0) // 2
- ($x3 $w_f $z0) // 3
- ($x0 $w_f $z1) // 4
- ($x1 $w_f $z1) // 5
- ($x2 $w_f $z1) // 6
- ($x3 $w_f $z1) // 7
- ($x0 $w_f $z2) // 8
- ($x1 $w_f $z2) // 9
- ($x2 $w_f $z2) // 10
- ($x3 $w_f $z2) // 11
-
- ($x0 $w_b $z0) // 12
- ($x1 $w_b $z0) // 13
- ($x2 $w_b $z0) // 14
- ($x3 $w_b $z0) // 15
- ($x0 $w_b $z1) // 16
- ($x1 $w_b $z1) // 17
- ($x2 $w_b $z1) // 18
- ($x3 $w_b $z1) // 19
- ($x0 $w_b $z2) // 20
- ($x1 $w_b $z2) // 21
- ($x2 $w_b $z2) // 22
- ($x3 $w_b $z2) // 23
-);
-
-// Grading
-h1 30;
-h2 3;
-v1 15;
-v2 30;
-
-blocks
-(
- hex ( 0 1 5 4 12 13 17 16 )
- ($h1 $v1 1 )
- simpleGrading (0.5 1 1)
-
- hex ( 2 3 7 6 14 15 19 18 )
- ($h1 $v1 1)
- simpleGrading (2 1 1)
-
- hex ( 4 5 9 8 16 17 21 20 )
- ($h1 $v2 1)
- simpleGrading (0.5 2 1)
-
- hex ( 5 6 10 9 17 18 22 21 )
- ($h2 $v2 1)
- simpleGrading (1 2 1)
-
- hex ( 6 7 11 10 18 19 23 22 )
- ($h1 $v2 1 )
- simpleGrading (2 2 1)
-);
-
-edges
-(
-);
-
-boundary
-(
- inlet
- {
- type patch;
- faces
- (
- ( 0 4 16 12 )
- ( 4 8 20 16 )
- );
- }
- outlet
- {
- type patch;
- faces
- (
- ( 3 7 19 15 )
- ( 7 11 23 19 )
- );
- }
- flap
- {
- type wall;
- faces
- (
- ( 1 5 17 13 )
- ( 5 6 18 17 )
- ( 6 2 14 18 )
- );
- }
- upperWall
- {
- type wall;
- faces
- (
- ( 8 9 21 20 )
- ( 9 10 22 21 )
- ( 10 11 23 22 )
- );
- }
- lowerWall
- {
- type wall;
- faces
- (
- ( 0 1 13 12 )
- ( 2 3 15 14 )
- );
- }
- frontAndBack
- {
- type empty;
- faces
- (
- ( 0 1 5 4 )
- ( 2 3 7 6 )
- ( 4 5 9 8 )
- ( 5 6 10 9 )
- ( 6 7 11 10 )
- ( 12 13 17 16 )
- ( 14 15 19 18 )
- ( 16 17 21 20 )
- ( 17 18 22 21 )
- ( 18 19 23 22 )
- );
- }
-);
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/decomposeParDict b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/decomposeParDict
deleted file mode 100644
index 1350cc23e..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/decomposeParDict
+++ /dev/null
@@ -1,24 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location system;
- object decomposeParDict;
-}
-
- numberOfSubdomains 6;
-
- method hierarchical;
- hierarchicalCoeffs
- {
- n (3 2 1);
- delta 0.001;
- order xyz;
- }
-
- distributed false;
- roots
- (
- );
-
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/displacementProbe b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/displacementProbe
deleted file mode 100644
index 2bad5f4af..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/displacementProbe
+++ /dev/null
@@ -1,18 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-Description
- Writes out values of fields from cells nearest to specified locations.
-
-\*---------------------------------------------------------------------------*/
-
-#includeEtc "caseDicts/postProcessing/probes/probes.cfg"
-type probes;
-probeLocations
-(
- (0 0.15 1.0)
-);
-fields
-(
- cellDisplacement
-);
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/preciceDict b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/preciceDict
deleted file mode 100644
index f5b1fd303..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/preciceDict
+++ /dev/null
@@ -1,54 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object preciceDict;
-}
-
-preciceConfig "precice-config.xml";
-
-participant Fluid;
-
-modules (FSI);
-
-interfaces
-{
- Interface1
- {
- mesh Fluid-Mesh-Faces;
- patches (flap);
- locations faceCenters;
-
- readData
- (
- );
-
- writeData
- (
- Forces0
- );
- };
-
- Interface2
- {
- mesh Fluid-Mesh-Nodes;
- patches (flap);
- locations faceNodes;
-
- readData
- (
- Displacements0
- );
-
- writeData
- (
- );
- };
-};
-
-FSI
-{
- rho rho [1 -3 0 0 0 0 0] 1;
-}
\ No newline at end of file
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/README.md b/FSI/flap_perp_2D/OpenFOAM-FEniCS/README.md
deleted file mode 100644
index d597cafbf..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/README.md
+++ /dev/null
@@ -1,29 +0,0 @@
-This is a tutorial for the perpendicular flap case using FEniCS as a structure solver and OpenFOAM for the Fluid.
-To run it you need:
-- preCICE
-- FEniCS
-- FEniCS Adapter for FSI
-- OpenFOAM + OpenFOAM Adapter (see comments on different OpenFOAM versions below)
-
-# Run it
-
-You can run the tutorial from this directory by typing ```python3 Solid/perp-flap.py``` in one Terminal and ```bash ./runFluid``` in another.
-
-## Different OpenFOAM versions
-
-For the different OpenFOAM versions supported by the OpenFOAM adapter, have a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-For this tutorial:
-* if you are using OpenFOAM 5 or older: just use the master branch of this repository together with the master branch of the OpenFOAM Adapter
-* if you are using OpenFOAM 6: use the branch called `OpenFOAM6` of this repository together with the branch called `OpenFOAM6` of the OpenFOAM Adapter
-* if you are using something else: more version of the OpenFOAM-Adapter are provided as branches of the adapter repository. However, this tutorial has not been tested with other versions of OpenFOAM.
-
-For more information, please refer to [this issue](https://github.com/precice/tutorials/issues/40).
-
-# Visualize Results
-
-To visualize the results open fluid.foam in paraview. If you want to look at the flap explicitely you can open the ```.pvd``` file in paraview.
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Solid/perp-flap.py b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Solid/perp-flap.py
deleted file mode 100644
index ee19aefca..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Solid/perp-flap.py
+++ /dev/null
@@ -1,248 +0,0 @@
-# Import required libs
-from fenics import Constant, Function, AutoSubDomain, RectangleMesh, VectorFunctionSpace, interpolate, \
- TrialFunction, TestFunction, Point, Expression, DirichletBC, nabla_grad, Identity, inner, dx, ds, \
- sym, grad, lhs, rhs, dot, File, solve, PointSource, assemble_system, MPI, MeshFunction
-from ufl import nabla_div
-import numpy as np
-import matplotlib.pyplot as plt
-from fenicsprecice import Adapter
-from enum import Enum
-
-
-# define the two kinds of boundary: clamped and coupling Neumann Boundary
-def clamped_boundary(x, on_boundary):
- return on_boundary and abs(x[1]) < tol
-
-
-def neumann_boundary(x, on_boundary):
- """
- determines whether a node is on the coupling boundary
-
- """
- return on_boundary and ((abs(x[1] - 1) < tol) or abs(abs(x[0]) - W / 2) < tol)
-
-
-# Geometry and material properties
-dim = 2 # number of dimensions
-H = 1
-W = 0.1
-rho = 3000
-E = 400000.0
-nu = 0.3
-
-mu = Constant(E / (2.0 * (1.0 + nu)))
-
-lambda_ = Constant(E * nu / ((1.0 + nu) * (1.0 - 2.0 * nu)))
-
-# create Mesh
-n_x_Direction = 5
-n_y_Direction = 50
-mesh = RectangleMesh(Point(-W / 2, 0), Point(W / 2, H), n_x_Direction, n_y_Direction)
-
-h = Constant(H / n_y_Direction)
-
-# create Function Space
-V = VectorFunctionSpace(mesh, 'P', 2)
-
-# BCs
-tol = 1E-14
-
-# Trial and Test Functions
-du = TrialFunction(V)
-v = TestFunction(V)
-
-u_np1 = Function(V)
-saved_u_old = Function(V)
-
-# function known from previous timestep
-u_n = Function(V)
-v_n = Function(V)
-a_n = Function(V)
-
-f_N_function = interpolate(Expression(("1", "0"), degree=1), V)
-u_function = interpolate(Expression(("0", "0"), degree=1), V)
-
-coupling_boundary = AutoSubDomain(neumann_boundary)
-fixed_boundary = AutoSubDomain(clamped_boundary)
-
-precice = Adapter(adapter_config_filename="precice-adapter-config-fsi-s.json")
-
-# Initialize the coupling interface
-# Function space V is passed twice as both read and write functions are defined using the same space
-precice_dt = precice.initialize(coupling_boundary, read_function_space=V, write_object=V, fixed_boundary=fixed_boundary)
-
-fenics_dt = precice_dt # if fenics_dt == precice_dt, no subcycling is applied
-# fenics_dt = 0.02 # if fenics_dt < precice_dt, subcycling is applied
-dt = Constant(np.min([precice_dt, fenics_dt]))
-
-# clamp the beam at the bottom
-bc = DirichletBC(V, Constant((0, 0)), fixed_boundary)
-
-# alpha method parameters
-alpha_m = Constant(0.2)
-alpha_f = Constant(0.4)
-gamma = Constant(0.5 + alpha_f - alpha_m)
-beta = Constant((gamma + 0.5)**2 / 4.)
-
-
-# Define strain
-def epsilon(u):
- return 0.5 * (nabla_grad(u) + nabla_grad(u).T)
-
-
-# Define Stress tensor
-def sigma(u):
- return lambda_ * nabla_div(u) * Identity(dim) + 2 * mu * epsilon(u)
-
-
-# Define Mass form
-def m(u, v):
- return rho * inner(u, v) * dx
-
-
-# Elastic stiffness form
-def k(u, v):
- return inner(sigma(u), sym(grad(v))) * dx
-
-
-# External Work
-def Wext(u_):
- return dot(u_, p) * ds
-
-
-# Update functions
-
-# Update acceleration
-def update_a(u, u_old, v_old, a_old, ufl=True):
- if ufl:
- dt_ = dt
- beta_ = beta
- else:
- dt_ = float(dt)
- beta_ = float(beta)
-
- return ((u - u_old - dt_ * v_old) / beta / dt_ ** 2
- - (1 - 2 * beta_) / 2 / beta_ * a_old)
-
-
-# Update velocity
-def update_v(a, u_old, v_old, a_old, ufl=True):
- if ufl:
- dt_ = dt
- gamma_ = gamma
- else:
- dt_ = float(dt)
- gamma_ = float(gamma)
-
- return v_old + dt_ * ((1 - gamma_) * a_old + gamma_ * a)
-
-
-def update_fields(u, u_old, v_old, a_old):
- """Update all fields at the end of a timestep."""
-
- u_vec, u0_vec = u.vector(), u_old.vector()
- v0_vec, a0_vec = v_old.vector(), a_old.vector()
-
- # call update functions
- a_vec = update_a(u_vec, u0_vec, v0_vec, a0_vec, ufl=False)
- v_vec = update_v(a_vec, u0_vec, v0_vec, a0_vec, ufl=False)
-
- # assign u->u_old
- v_old.vector()[:], a_old.vector()[:] = v_vec, a_vec
- u_old.vector()[:] = u.vector()
-
-
-def avg(x_old, x_new, alpha):
- return alpha * x_old + (1 - alpha) * x_new
-
-
-# residual
-a_np1 = update_a(du, u_n, v_n, a_n, ufl=True)
-v_np1 = update_v(a_np1, u_n, v_n, a_n, ufl=True)
-
-res = m(avg(a_n, a_np1, alpha_m), v) + k(avg(u_n, du, alpha_f), v)
-
-a_form = lhs(res)
-L_form = rhs(res)
-
-# parameters for Time-Stepping
-t = 0.0
-n = 0
-time = []
-u_tip = []
-time.append(0.0)
-u_tip.append(0.0)
-E_ext = 0
-
-# mark mesh w.r.t ranks
-mesh_rank = MeshFunction("size_t", mesh, mesh.topology().dim())
-mesh_rank.set_all(MPI.rank(MPI.comm_world) + 0)
-mesh_rank.rename("myRank", "")
-
-displacement_out = File("Solid/FSI-S/u_fsi.pvd")
-ranks = File("Solid/FSI-S/ranks%s.pvd" % precice.get_participant_name())
-
-u_n.rename("Displacement", "")
-u_np1.rename("Displacement", "")
-displacement_out << u_n
-ranks << mesh_rank
-
-while precice.is_coupling_ongoing():
-
- if precice.is_action_required(precice.action_write_iteration_checkpoint()): # write checkpoint
- precice.store_checkpoint(u_n, t, n)
-
- # read data from preCICE and get a new coupling expression
- read_data = precice.read_data()
-
- # Update the point sources on the coupling boundary with the new read data
- Forces_x, Forces_y = precice.get_point_sources(read_data)
-
- A, b = assemble_system(a_form, L_form, bc)
-
- b_forces = b.copy() # b is the same for every iteration, only forces change
-
- for ps in Forces_x:
- ps.apply(b_forces)
- for ps in Forces_y:
- ps.apply(b_forces)
-
- assert (b is not b_forces)
- solve(A, u_np1.vector(), b_forces)
-
- dt = Constant(np.min([precice_dt, fenics_dt]))
-
- # Write new displacements to preCICE
- precice.write_data(u_np1)
-
- # Call to advance coupling, also returns the optimum time step value
- precice_dt = precice.advance(dt(0))
-
- # Either revert to old step if timestep has not converged or move to next timestep
- if precice.is_action_required(precice.action_read_iteration_checkpoint()): # roll back to checkpoint
- u_cp, t_cp, n_cp = precice.retrieve_checkpoint()
- u_n.assign(u_cp)
- t = t_cp
- n = n_cp
- else:
- u_n.assign(u_np1)
- t += float(dt)
- n += 1
-
- if precice.is_time_window_complete():
- update_fields(u_np1, saved_u_old, v_n, a_n)
- if n % 10 == 0:
- displacement_out << (u_n, t)
-
- u_tip.append(u_n(0., 1.)[0])
- time.append(t)
-
-# Plot tip displacement evolution
-displacement_out << u_n
-plt.figure()
-plt.plot(time, u_tip)
-plt.xlabel("Time")
-plt.ylabel("Tip displacement")
-plt.show()
-
-precice.finalize()
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Solid/precice-adapter-config-fsi-s.json b/FSI/flap_perp_2D/OpenFOAM-FEniCS/Solid/precice-adapter-config-fsi-s.json
deleted file mode 100644
index 1b9be8c19..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Solid/precice-adapter-config-fsi-s.json
+++ /dev/null
@@ -1,9 +0,0 @@
-{
- "participant_name": "fenics",
- "config_file_name": "../precice-config.xml",
- "interface": {
- "coupling_mesh_name": "Solid",
- "write_data_name": "Displacements0",
- "read_data_name": "Forces0"
- }
-}
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/precice-config.xml b/FSI/flap_perp_2D/OpenFOAM-FEniCS/precice-config.xml
deleted file mode 100644
index 3f42e25ce..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/precice-config.xml
+++ /dev/null
@@ -1,81 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/removeObsoleteFolders.sh b/FSI/flap_perp_2D/OpenFOAM-FEniCS/removeObsoleteFolders.sh
deleted file mode 100755
index 80288fe27..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,23 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
-
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/runFluid b/FSI/flap_perp_2D/OpenFOAM-FEniCS/runFluid
deleted file mode 100755
index d512d9e74..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/runFluid
+++ /dev/null
@@ -1,49 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the "runSolid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- #make the z-axis the y-axis such that the simulation is in the xy-plane
- transformPoints -rotate '((0 0 1) (0 1 0))'
- solver=$(getApplication)
-cd ..
-
-echo " ### WARNING ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
-
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $(getNumberOfProcessors) $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26
-./removeObsoleteFolders.sh
-
-rm -r Fluid/0/
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/.gitignore b/FSI/flap_perp_2D/OpenFOAM-deal.II/.gitignore
deleted file mode 100644
index 1528733d2..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/.gitignore
+++ /dev/null
@@ -1,9 +0,0 @@
-Fluid
-!Fluid/0
-!Fluid/0.orig
-!Fluid/constant
-!Fluid/system
-!Fluid/Fluid.foam
-*.vtk
-*.log
-~
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Allclean b/FSI/flap_perp_2D/OpenFOAM-deal.II/Allclean
deleted file mode 100755
index 58874b09c..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Allclean
+++ /dev/null
@@ -1,56 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-# Participant 1: Fluid (OpenFOAM)
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the case
- cleanCase
- rm -rfv 0
- # Create an empty .foam file for ParaView
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
- touch ${Participant1}.foam
-cd ..
-# Remove the log files
-rm -fv ${Participant1}_blockMesh.log
-rm -fv ${Participant1}_checkMesh.log
-rm -fv ${Participant1}_decomposePar.log
-rm -fv ${Participant1}.log
-rm -fv ${Participant1}_reconstructPar.log
-
-# Participant 2: Solid (deal.II)
-Participant2="Solid"
-cd ./Solid/dealii_output
- # Clean the case
- echo "Cleaning Solid case"
- rm -fv solution-*.vtk
-cd ..
- rm -fv solution-*.vtk
-cd ..
-
-rm -fv ${Participant2}.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-rm -rfv precice-run
-rm -fv .${Participant1}-${Participant2}.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Allrun b/FSI/flap_perp_2D/OpenFOAM-deal.II/Allrun
deleted file mode 100755
index 370f5c26c..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Allrun
+++ /dev/null
@@ -1,107 +0,0 @@
-#!/bin/bash
-
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the script "runFluid" and start the Solid participant manually
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-
- # Prepare
- echo "Preparing the ${Participant1} participant..."
-
- cd $Participant1
- echo " Restoring 0/ from 0.orig/..."
- rm -rfv 0
- cp -r 0.orig 0
- cd ..
-
- echo " Preparing the mesh..."
- blockMesh -case ${Participant1} > ${Participant1}_blockMesh.log 2>&1
- checkMesh -case ${Participant1} > ${Participant1}_checkMesh.log 2>&1
-
- # get application information
- cd ${Participant1}
- Solver1=$(getApplication) # solver
- echo " ${Participant1} Solver: ${Solver1}."
- cd ..
-
- # Run and get the process id
- if [ $parallel -eq 1 ]; then
- echo " Decomposing the case..."
- decomposePar -force -case ${Participant1} > ${Participant1}_decomposePar.log 2>&1
- cd ${Participant1}
- nproc=$(getNumberOfProcessors)
- cd ..
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} -parallel -case ${Participant1} > ${Participant1}.log 2>&1 &
- else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} -case ${Participant1} > ${Participant1}.log 2>&1 &
- fi
- PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-Solver2="linear_elasticity"
-
- # Run
- echo " Starting the ${Participant2} participant..."
- ./runSolid -linear > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
- if [ $parallel -eq 1 ]; then
- echo "Reconstructing fields..."
- reconstructPar -case ${Participant1} > ${Participant1}_reconstructPar.log 2>&1 &
- fi
-
- # Workaround for issue #26
- echo "Problems with time directories without results? Run the script removeObsoleteFolders.sh and see issue #26 on GitHub."
- # ./removeObsoleteFolders.sh
-
- echo "You may now open '${Participant1}/${Participant1}.foam' in ParaView."
- # Note: ".foam" triggers the native OpenFOAM reader of ParaView.
- # Change to ".OpenFOAM" to use the OpenFOAM reader provided with OpenFOAM.
-fi
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/U b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/U
deleted file mode 100644
index 9bfbc4ea3..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/U
+++ /dev/null
@@ -1,46 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- location "0";
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (10 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value $internalField;
- }
- outlet
- {
- type zeroGradient;
- }
- flap
- {
- type movingWallVelocity;
- value uniform (0 0 0);
- }
- upperWall
- {
- type noSlip;
- }
- lowerWall
- {
- type noSlip;
- }
- frontAndBack
- {
- type empty;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/p b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/p
deleted file mode 100644
index a558fafcf..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/p
+++ /dev/null
@@ -1,48 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 2 -2 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- inlet
- {
- type zeroGradient;
- }
-
- outlet
- {
- type fixedValue;
- value uniform 0;
- }
-
- flap
- {
- type zeroGradient;
- }
-
- upperWall
- {
- type zeroGradient;
- }
-
- lowerWall
- {
- type zeroGradient;
- }
-
- frontAndBack
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/phi b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/phi
deleted file mode 100644
index 06c61d9c4..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/phi
+++ /dev/null
@@ -1,49 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class surfaceScalarField;
- location "0";
- object phi;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 3 -1 0 0 0 0];
-
-internalField uniform 0;
-boundaryField
-{
- inlet
- {
- type calculated;
- value $internalField;
- }
- outlet
- {
- type calculated;
- value $internalField;
- }
- flap
- {
- type calculated;
- value uniform 0;
- }
- upperWall
- {
- type calculated;
- value uniform 0;
- }
- lowerWall
- {
- type calculated;
- value uniform 0;
- }
- frontAndBack
- {
- type empty;
- value nonuniform 0;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
deleted file mode 100644
index c107f3b65..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
+++ /dev/null
@@ -1,50 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class pointVectorField;
- object pointDisplacement;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 0 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- outlet
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- flap
- {
- type fixedValue;
- value $internalField;
- }
-
- upperWall
- {
- type slip;
- }
-
- lowerWall
- {
- type slip;
- }
-
- frontAndBack
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/Fluid.foam b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/Fluid.foam
deleted file mode 100644
index e69de29bb..000000000
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict
deleted file mode 100644
index d323bc059..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict
+++ /dev/null
@@ -1,22 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object dynamicMeshDict;
-}
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dynamicFvMesh dynamicMotionSolverFvMesh;
-
-motionSolverLibs ("libfvMotionSolvers.so");
-
-solver displacementLaplacian;
-
-displacementLaplacianCoeffs {
-
- diffusivity quadratic inverseDistance (flap);
-
-}
\ No newline at end of file
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/displacementProbe b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/displacementProbe
deleted file mode 100644
index 2bad5f4af..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/displacementProbe
+++ /dev/null
@@ -1,18 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-Description
- Writes out values of fields from cells nearest to specified locations.
-
-\*---------------------------------------------------------------------------*/
-
-#includeEtc "caseDicts/postProcessing/probes/probes.cfg"
-type probes;
-probeLocations
-(
- (0 0.15 1.0)
-);
-fields
-(
- cellDisplacement
-);
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/preciceDict b/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/preciceDict
deleted file mode 100644
index fd11cf9fc..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/preciceDict
+++ /dev/null
@@ -1,54 +0,0 @@
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object preciceDict;
-}
-
-preciceConfig "precice-config.xml";
-
-participant Fluid;
-
-modules (FSI);
-
-interfaces
-{
- Interface1
- {
- mesh Fluid-Mesh-Centers;
- patches (flap);
- locations faceCenters;
-
- readData
- (
- );
-
- writeData
- (
- Stress
- );
- };
-
- Interface2
- {
- mesh Fluid-Mesh-Nodes;
- patches (flap);
- locations faceNodes;
-
- readData
- (
- Displacement
- );
-
- writeData
- (
- );
- };
-};
-
-FSI
-{
- rho rho [1 -3 0 0 0 0 0] 1;
-}
\ No newline at end of file
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/README.md b/FSI/flap_perp_2D/OpenFOAM-deal.II/README.md
deleted file mode 100644
index f86d5a7ba..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/README.md
+++ /dev/null
@@ -1,18 +0,0 @@
-# Tutorial for an FSI simulation of an elastic flap perpendicular to a channel flow
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM). Have also a look into our [Notes on OpenFOAM](https://github.com/precice/openfoam-adapter/wiki/Notes-on-OpenFOAM).
-
-You may run the coupled simulation in serial using the script `Allrun` or (OpenFOAM) in parallel with `Allrun -parallel`. The output of each step will be redirected to log files. You can cleanup the simulation using `Allclean`.
-
-If you prefer to run the two simulations in two different terminals and watch their output on the screen, use the (simpler) scripts `runFluid` (or `runFluid -parallel`).
-
-Before starting the deal.II program, it needs to be compiled and copied in this case directory. Information about building is collected in the [deal.II wiki](https://github.com/precice/dealii-adapter/wiki/Building). You can use the following command to run e.g. the linear deal.II solver afterwards:
-```
-./runSolid -linear
-```
-
-There is an [open issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. Please run the script `removeObsoleteSolvers.sh` to delete the additional files.
-
-## Disclaimer
-
-This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks.
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/linear_elasticity.prm b/FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/linear_elasticity.prm
deleted file mode 100644
index 4793d0bc6..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/linear_elasticity.prm
+++ /dev/null
@@ -1,68 +0,0 @@
-# Listing of Parameters
-# Dimensional quantities are in SI units
-# --------------------------------------
-
-subsection Time
- # End time
- set End time = 5
-
- # Time step size
- set Time step size = 0.01
-
- # Write results every x timesteps
- set Output interval = 10
-end
-
-subsection Discretization
- # Time integration scheme
- # 0 = forward, 1 = backward
- set theta = 0.5
-
- # Polynomial degree of the FE system
- set Polynomial degree = 4
-end
-
-subsection System properties
- # mu (shear modulus)
- set mu = 153846
-
- # lambda
- set lambda = 230769
-
- # density
- set rho = 3000
-
- # body forces x,y,z
- set body forces = 0.0,0.0,0.0
-end
-
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
-
- # Linear solver: CG or Direct
- set Solver type = Direct
-end
-
-subsection precice configuration
- # Cases: FSI3 or PF for perpendicular flap
- set Scenario = PF
-
- # Name of the precice configuration file
- set precice config-file = precice-config.xml
-
- # Name of the participant in the precice-config.xml file
- set Participant name = Solid
-
- # Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
-
- # Name of the read data in the precice-config.xml file
- set Read data name = Stress
-
- # Name of the write data in the precice-config.xml file
- set Write data name = Displacement
-end
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm b/FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
deleted file mode 100644
index 9aaf619d8..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
+++ /dev/null
@@ -1,81 +0,0 @@
-# Listing of Parameters
-# Dimensional quantities are in SI units
-# --------------------------------------
-
-subsection Time
- # End time
- set End time = 5
-
- # Time step size
- set Time step size = 0.01
-
- # Output interval
- set Output interval = 10
-end
-
-subsection Discretization
- # Newmark beta
- set beta = 0.25
-
- # Newmark gamma
- set gamma = 0.5
-
- # Polynomial degree of the FE system
- set Polynomial degree = 4
-end
-
-subsection System properties
- # Poisson's ratio
- set Poisson's ratio = 0.375
-
- # Shear modulus
- set Shear modulus = 153846
-
- # Density
- set rho = 3000
-
- # Body forces x,y,z
- set body forces = 0.0,0.0,0.0
-end
-
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
-
- # Linear solver: CG or Direct
- set Solver type = Direct
-end
-
-subsection Nonlinear solver
- # Number of Newton-Raphson iterations allowed
- set Max iterations Newton-Raphson = 10
-
- # Displacement error tolerance
- set Tolerance displacement = 1.0e-6
-
- # Force residual tolerance
- set Tolerance force = 1.0e-9
-end
-
-subsection precice configuration
- # Cases: FSI3 or PF for perpendicular flap
- set Scenario = PF
-
- # Name of the precice configuration file
- set precice config-file = precice-config.xml
-
- # Name of the participant in the precice-config.xml file
- set Participant name = Solid
-
- # Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
-
- # Name of the read data in the precice-config.xml file
- set Read data name = Stress
-
- # Name of the write data in the precice-config.xml file
- set Write data name = Displacement
-end
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/plotDisplacement.sh b/FSI/flap_perp_2D/OpenFOAM-deal.II/plotDisplacement.sh
deleted file mode 100755
index c83fa1dde..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/plotDisplacement.sh
+++ /dev/null
@@ -1,13 +0,0 @@
-#! /bin/bash
-gnuplot -p << EOF
-set grid
-set title 'Displacement of the Flap Tip'
-set xlabel 'Time [s]'
-set ylabel 'X-Displacement [m]'
-# set style line 1 lt 2 lw 6
-# set style line 1 lt 2 lw 6
-# set linestyle 2 lt 2 lc 1 # red-dashed
-set linestyle 1 lt 2 lc 1 # red-dashed
-plot "precice-Solid-watchpoint-flap_tip.log" using 1:4 title 'Top displacemement' with lines
-EOF
-
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/precice-config.xml b/FSI/flap_perp_2D/OpenFOAM-deal.II/precice-config.xml
deleted file mode 100644
index 79389f345..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/precice-config.xml
+++ /dev/null
@@ -1,82 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/removeObsoleteFolders.sh b/FSI/flap_perp_2D/OpenFOAM-deal.II/removeObsoleteFolders.sh
deleted file mode 100755
index 6866c8c42..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/removeObsoleteFolders.sh
+++ /dev/null
@@ -1,22 +0,0 @@
-#! /bin/bash
-
-echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see issue #26 on GitHub)..."
-
-cd Fluid
-for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
-done
-if [ -d processor0 ]; then
- for g in processor*; do
- cd $g
- for f in [0-9]* [0-9]*.[0-9]*; do
- if ! [ -f $f/U ] && ! [ -f $f/T ]; then
- rm -rfv $f
- fi
- done
- cd ..
- done
-fi
-cd ..
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/runFluid b/FSI/flap_perp_2D/OpenFOAM-deal.II/runFluid
deleted file mode 100755
index ea982c12e..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/runFluid
+++ /dev/null
@@ -1,44 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-. $WM_PROJECT_DIR/bin/tools/RunFunctions # Tutorial run functions
-
-# Fluid participant
-
-# Run this script in one terminal and the execute the runSolid in another terminal.
-# These scripts present how the two participants would be started manually.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-rm -rfv Fluid/0/
-cp -r Fluid/0.orig/ Fluid/0/
-blockMesh -case Fluid
-checkMesh -case Fluid
-
-# Run
-cd Fluid
- solver=$(getApplication)
- procs=$(getNumberOfProcessors)
-cd ..
-if [ $parallel -eq 1 ]; then
- decomposePar -force -case Fluid
- mpirun -np $procs $solver -parallel -case Fluid
- reconstructPar -case Fluid
-else
- $solver -case Fluid
-fi
-
-# Workaround for issue #26 (OF-adapter, relevant for OF .com versions)
-./removeObsoleteFolders.sh
-
-echo ""
-echo "### NOTE ### Make sure to use the correct solver for your OpenFOAM version! (pimpleFoam for OpenFOAM v1806, OpenFOAM 6, or newer, vs pimpleDyMFoam for older) You may change this in your Fluid/system/controlDict file, if needed."
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/runSolid b/FSI/flap_perp_2D/OpenFOAM-deal.II/runSolid
deleted file mode 100755
index 7e6fe12c3..000000000
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/runSolid
+++ /dev/null
@@ -1,27 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-
-# Solid participant
-
-# Run this script in one terminal and the execute the Fluid participant
-# in another terminal.
-# These scripts present how the two participants would be started manually.
-
-# 1 for true, 0 for false
-nonlinear=0
-if [ "$1" = "-nonlinear" ]; then
- nonlinear=1
-fi
-
-linear=0
-if [ "$1" = "-linear" ]; then
- linear=1
-fi
-
-if [ $linear -eq 1 ]; then
- ./linear_elasticity Solid/linear_elasticity.prm
-elif [ $nonlinear -eq 1 ]; then
- ./nonlinear_elasticity Solid/nonlinear_elasticity.prm
-else
- echo "No solver type specified. Please specify -linear or -nonlinear as solver type"
-fi
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/Allclean b/FSI/flap_perp_2D/SU2-FEniCS/Allclean
deleted file mode 100755
index 5a1164eb9..000000000
--- a/FSI/flap_perp_2D/SU2-FEniCS/Allclean
+++ /dev/null
@@ -1,53 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
-
-echo "Cleaning..."
-
-# Participant 1: Fluid
-Participant1="Fluid"
-cd ${Participant1}
- # Clean the result and auxiliary files
- rm -fv flow_*.vtk
- rm -fv history_*.vtk
- rm -fv restart_flow_*.dat
- rm -fv forces_breakdown.dat
- rm -fv surface_flow_*.csv
-cd ..
-
-# Remove the log files
-rm -fv ${Participant1}.log
-rm -fv Output/*.log
-
-# Participant 2: Solid
-Participant2="Solid"
-cd ${Participant2}
- # Clean the case
- rm -fv *.log
- rm -fv *.vtk
- rm -fv *.pvd
- rm -fv FSI-S/*
-cd ..
-# Remove the log files
-rm -fv spooles.out
-rm -fv ${Participant2}.log
-
-# Remove the preCICE-related log files
-echo "Deleting the preCICE log files..."
-rm -fv \
- precice-*.log \
- precice-postProcessingInfo.log \
- precice-*-events.json
-
-# Output files for preCICE versions before 1.2:
-rm -fv \
- iterations-${Participant1}.txt iterations-${Participant2}.txt \
- convergence-${Participant1}.txt convergence-${Participant2}.txt \
- Events-${Participant1}.log Events-${Participant2}.log \
- EventTimings-${Participant1}.log EventTimings-${Participant2}.log
-
-# Remove the preCICE address files
-rm -rfv precice-run
-rm -fv .*.address
-
-echo "Cleaning complete!"
-#------------------------------------------------------------------------------
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/Allrun b/FSI/flap_perp_2D/SU2-FEniCS/Allrun
deleted file mode 100755
index 71f825f04..000000000
--- a/FSI/flap_perp_2D/SU2-FEniCS/Allrun
+++ /dev/null
@@ -1,66 +0,0 @@
-#!/bin/bash
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# Alternatively, you may execute the scripts "runSolid" and "runFluid"
-# in separate terminals.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-# Set up the run parameters:
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-# =============== Participant 1: Fluid ===========================
-Participant1="Fluid"
-Solver1="SU2_CFD"
-nproc=2
-
-# Run and get the process id
-if [ $parallel -eq 1 ]; then
- echo " Starting the ${Participant1} participant in parallel..."
- mpirun -np ${nproc} ${Solver1} Fluid/euler_config_coupled.cfg > ${Participant1}.log 2>&1 &
-else
- echo " Starting the ${Participant1} participant in serial..."
- ${Solver1} Fluid/euler_config_coupled.cfg > ${Participant1}.log 2>&1 &
-fi
-PIDParticipant1=$!
-
-# =============== Participant 2: Solid ===========================
-Participant2="Solid"
-
-# Run
-echo " Starting the ${Participant2} participant..."
-python3 ${Participant2}/perp-flap.py > ${Participant2}.log 2>&1 &
-PIDParticipant2=$!
-
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-
-echo "To interrupt the simulation, press 'c'. Ctrl+C will only send the processes to the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
-
-if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # Precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed! (check for any errors)"
-fi
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/README.md b/FSI/flap_perp_2D/SU2-FEniCS/README.md
deleted file mode 100644
index 3872e6523..000000000
--- a/FSI/flap_perp_2D/SU2-FEniCS/README.md
+++ /dev/null
@@ -1,5 +0,0 @@
-# Tutorial for a coupled simulation with SU2 and FEniCS
-
-The files in this folder can be used to run the tutorial test case described on this [Wiki page](https://github.com/precice/precice/wiki/FSI-tutorial) except that the structural solver is now FEniCS.
-For running the case execute the script `Allrun` in one terminal or the scripts `runSolid` and `runFluid` in separate terminals.
-Output data and visualization capabilites are similar to the case described in the above link.
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/Solid/precice-adapter-config-fsi-s.json b/FSI/flap_perp_2D/SU2-FEniCS/Solid/precice-adapter-config-fsi-s.json
deleted file mode 100644
index aaa992946..000000000
--- a/FSI/flap_perp_2D/SU2-FEniCS/Solid/precice-adapter-config-fsi-s.json
+++ /dev/null
@@ -1,9 +0,0 @@
-{
- "participant_name": "FEniCS",
- "config_file_name": "../precice-config.xml",
- "interface": {
- "coupling_mesh_name": "FEniCS_Mesh",
- "write_data_name": "DisplacementDeltas0",
- "read_data_name": "Forces0"
- }
-}
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/precice-config.xml b/FSI/flap_perp_2D/SU2-FEniCS/precice-config.xml
deleted file mode 100644
index 19081edb7..000000000
--- a/FSI/flap_perp_2D/SU2-FEniCS/precice-config.xml
+++ /dev/null
@@ -1,71 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/runFluid b/FSI/flap_perp_2D/SU2-FEniCS/runFluid
deleted file mode 100755
index 7527d01a6..000000000
--- a/FSI/flap_perp_2D/SU2-FEniCS/runFluid
+++ /dev/null
@@ -1,25 +0,0 @@
-#!/bin/bash
-
-# Fluid participant
-
-# Run this script in one terminal and the "runSolid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# Run this script with "-parallel" for parallel simulations
-
-# The script "Allclean" cleans-up the result and log files.
-
-# 1 for true, 0 for false
-parallel=0
-if [ "$1" = "-parallel" ]; then
- parallel=1
-fi
-
-echo "Preparing and running the Fluid participant..."
-
-if [ $parallel -eq 1 ]; then
- mpirun -n 2 SU2_CFD Fluid/euler_config_coupled.cfg 2>&1 | tee Fluid.log
-else
- SU2_CFD Fluid/euler_config_coupled.cfg 2>&1 | tee Fluid.log
-fi
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/runSolid b/FSI/flap_perp_2D/SU2-FEniCS/runSolid
deleted file mode 100755
index 026cb4a3a..000000000
--- a/FSI/flap_perp_2D/SU2-FEniCS/runSolid
+++ /dev/null
@@ -1,14 +0,0 @@
-#!/bin/bash
-
-# Solid participant
-
-# Run this script in one terminal and the "runFluid" script in another terminal.
-# These scripts present how the two participants would be started manually.
-# Alternatively, you may execute the "Allrun" script in one terminal.
-
-# The script "Allclean" cleans-up the result and log files.
-
-echo "Running the Solid participant..."
-
-# Run
-python3 Solid/perp-flap.py 2>&1 | tee Solid.log
diff --git a/HT/partitioned-heat/fenics-fenics/Allclean b/HT/partitioned-heat/fenics-fenics/Allclean
deleted file mode 100755
index 1dbf98f13..000000000
--- a/HT/partitioned-heat/fenics-fenics/Allclean
+++ /dev/null
@@ -1,11 +0,0 @@
-#!/bin/bash
-
-echo "Cleaning logs and output files from previous runs..."
-
-rm -r precice-run/
-
-rm out/*
-
-rm -f *.log
-
-echo "Cleaning successful!"
diff --git a/HT/partitioned-heat/fenics-fenics/README.md b/HT/partitioned-heat/fenics-fenics/README.md
deleted file mode 100644
index 44a8987c7..000000000
--- a/HT/partitioned-heat/fenics-fenics/README.md
+++ /dev/null
@@ -1,3 +0,0 @@
-# Tutorial for a partitioned heat equation using FEniCS
-
-This tutorial is described in the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-solving-the-heat-equation-in-a-partitioned-fashion-using-FEniCS).
diff --git a/HT/partitioned-heat/fenics-fenics/errorcomputation.py b/HT/partitioned-heat/fenics-fenics/errorcomputation.py
deleted file mode 100644
index 8964cd884..000000000
--- a/HT/partitioned-heat/fenics-fenics/errorcomputation.py
+++ /dev/null
@@ -1,13 +0,0 @@
-from fenics import inner, assemble, dx, project, sqrt
-
-
-def compute_errors(u_approx, u_ref, V, total_error_tol=10 ** -4):
- error_normalized = (u_ref - u_approx) / u_ref # compute pointwise L2 error
- error_pointwise = project(abs(error_normalized), V) # project onto function space
- error_total = sqrt(
- assemble(inner(error_pointwise, error_pointwise) * dx)) # determine L2 norm to estimate total error
- error_pointwise.rename("error", " ")
-
- assert (error_total < total_error_tol)
-
- return error_total, error_pointwise
diff --git a/HT/partitioned-heat/fenics-fenics/precice-adapter-config-D.json b/HT/partitioned-heat/fenics-fenics/precice-adapter-config-D.json
deleted file mode 100644
index 46addb18c..000000000
--- a/HT/partitioned-heat/fenics-fenics/precice-adapter-config-D.json
+++ /dev/null
@@ -1,9 +0,0 @@
-{
- "participant_name": "HeatDirichlet",
- "config_file_name": "precice-config.xml",
- "interface": {
- "coupling_mesh_name": "DirichletNodes",
- "write_data_name": "Flux",
- "read_data_name": "Temperature"
- }
-}
diff --git a/HT/partitioned-heat/fenics-fenics/precice-adapter-config-N.json b/HT/partitioned-heat/fenics-fenics/precice-adapter-config-N.json
deleted file mode 100644
index 335a2b9b8..000000000
--- a/HT/partitioned-heat/fenics-fenics/precice-adapter-config-N.json
+++ /dev/null
@@ -1,9 +0,0 @@
-{
- "participant_name": "HeatNeumann",
- "config_file_name": "precice-config.xml",
- "interface": {
- "coupling_mesh_name": "NeumannNodes",
- "write_data_name": "Temperature",
- "read_data_name": "Flux"
- }
-}
diff --git a/HT/partitioned-heat/fenics-fenics/precice-config.xml b/HT/partitioned-heat/fenics-fenics/precice-config.xml
deleted file mode 100644
index 129a7fcf0..000000000
--- a/HT/partitioned-heat/fenics-fenics/precice-config.xml
+++ /dev/null
@@ -1,61 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/HT/partitioned-heat/fenics-fenics/requirements.txt b/HT/partitioned-heat/fenics-fenics/requirements.txt
deleted file mode 100644
index 35b228acf..000000000
--- a/HT/partitioned-heat/fenics-fenics/requirements.txt
+++ /dev/null
@@ -1,5 +0,0 @@
-precice
-enum34
-numpy
-fenics
-mpi4py
diff --git a/README.md b/README.md
index 9db79ca25..6e5b5b0f9 100644
--- a/README.md
+++ b/README.md
@@ -1,35 +1,8 @@
-# preCICE Tutorials
+# preCICE tutorials
This repository contains ready-to-run tutorial cases for the coupling library [preCICE](http://www.precice.org/).
+The purpose of these cases is not to teach you how to use preCICE from scratch, but to serve as starting points for setting up similar simulation cases, as well as test cases. Read more on our [preCICE tutorials](https://www.precice.org/tutorials.html) documentation section.
-You may find step-by-step instructions for each case in the [preCICE wiki](https://github.com/precice/precice/wiki). *More tutorials come with each adapter* and you can also find them in the wiki.
+As a general rule, you can start each participant from inside their `/-` using `./run.sh`. Look into these short scripts and copy the parts you need for your new case. Before running again, execute the cleaning scripts you can find at each level, to clean from this point and deeper.
-The files in this repository are organized in the form `problem_type/geometry/solvers`. The following cases are currently provided:
-
-* `CHT`: Conjugate Heat Transfer
- * `heat_exchanger`: A shell-and-tube heat exchanger
- * `buoyantSimpleFoam-CalculiX`
- * `flow-over-plate`: A channel flow over a hot plate
- * `buoyantPimpleFoam-fenics`: for running see `README.md`
- * `buoyantPimpleFoam-nutils`: for running see `README.md`
- * `buoyantSimpleFoam-Aster` : for running see the [preCICE wiki](https://github.com/precice/code_aster-adapter/wiki/Flow-over-plate-Code_Aster-Tutorial)
-* `HT`: Heat Transfer
- * `partitioned-heat`: Solving heat equation on a partitioned domain
- * `fenics-fenics`: for running see `README.md`
-* `FSI`: Fluid-Structure Interaction
- * `flap_perp`: A flap attached on the walls of a channel, perpendicular to the flow
- * `SU2-CalculiX`
- * `OpenFOAM-CalculiX`
- * `OpenFOAM-deal.II`: for running see the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM)
- * `flap_perp_2D`: 2D version of flap_perp
- * `OpenFOAM-deal.II`: for running see the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM)
- * `cylinderFlap`: A cylinder with a flexible flap in a channel flow. The von Karman vortices cause the flap to oscillate.
- * `OpenFOAM-CalculiX`
- * `OpenFOAM-deal.II`: for running see the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM)
- * `cylinderFlap_2D`: 2D version of flap_perp
- * `OpenFOAM-deal.II`: for running see the [preCICE wiki](https://github.com/precice/precice/wiki/Tutorial-for-FSI-with-deal.II-and-OpenFOAM)
- * `3D_Tube`: A 3D expanding tube with a pressure inlet boundary condition.
- * `OpenFOAM-CalculiX`
-* `SSI`: Structure-Structure Interaction
- * `loaded_beam`: A partitioned elastic beam fixed at both ends. A mechanical force is applied to one partition.
- * `CalculiX-CalculiX`
+Contributions to this repository are very welcome. Please refer to the page [Contribute to preCICE](https://precice.org/community-contribute-to-precice.html) for a few guidelines and hints to help you in this direction.
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/Allrun b/SSI/loaded_beam/CalculiX-CalculiX/Allrun
deleted file mode 100755
index c6ee5bbea..000000000
--- a/SSI/loaded_beam/CalculiX-CalculiX/Allrun
+++ /dev/null
@@ -1,51 +0,0 @@
-#!/bin/bash
-cd ${0%/*} || exit 1 # Run from this directory
-
-# This script prepares and runs all the participants in one terminal,
-# forwarding the solvers' output to log files.
-# You need to first download the mesh files separately using the Download_meshes script.
-# The script "Allclean" cleans-up the result and log files.
-
-# Participant 1: Calculix1Mesh
-Participant1="Calculix1Mesh"
-CalculixSolver="/path/to/Calculix/ccx_preCICE"
-
- # Run and get the process id
- echo "Starting the ${Participant1} participant..."
- export OMP_NUM_THREADS=1
- export CCX_NPROC_EQUATION_SOLVER=1
- ${CalculixSolver} -i beam1 -precice-participant Calculix1 > ${Participant1}.log 2>&1 &
- PIDParticipant1=$!
-
-# Participant 2: Calculix2Mesh
-Participant2="Calculix2Mesh"
-
- # Run and get the process id
- echo "Starting the ${Participant2} participant..."
- export OMP_NUM_THREADS=1
- export CCX_NPROC_EQUATION_SOLVER=1
- ${CalculixSolver} -i beam2 -precice-participant Calculix2 > ${Participant2}.log 2>&1 &
- PIDParticipant2=$!
-
-# =============== Wait for all the participants to finish =======
-echo "Waiting for the participants to exit..., PIDs: ${PIDParticipant1}, ${PIDParticipant2}"
-echo "(you may run 'tail -f ${Participant1}.log' in another terminal to check the progress)"
-echo "To kill midrun, press 'c'. Ctrl+C will cause the processes to run in the background."
-while [ -e /proc/${PIDParticipant1} ]; do
- read -r -t1 -n1 input
- if [ "$input" = "c" ]; then
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
- false
- fi
-done
- if [ $? -ne 0 ] || [ "$(grep -c -E "error:" ${Participant1}.log)" -ne 0 ] || [ "$(grep -c -E "error:" ${Participant2}.log)" -ne 0 ]; then
- echo ""
- echo "Something went wrong... See the log files for more."
- # precaution
- kill ${PIDParticipant1}
- kill ${PIDParticipant2}
-else
- echo ""
- echo "The simulation completed!"
-fi
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/README.md b/SSI/loaded_beam/CalculiX-CalculiX/README.md
deleted file mode 100644
index dead46e0d..000000000
--- a/SSI/loaded_beam/CalculiX-CalculiX/README.md
+++ /dev/null
@@ -1,3 +0,0 @@
-# Tutorial for a coupled simulation with two instances of CalculiX
-
-The files in this folder can be used to run the tutorial test case described on this [Wiki page](https://github.com/precice/precice/wiki/Tutorial-for-SSI-with-CalculiX). For running the case either follow the instructions given there or execute the script `runTutorial.sh`.
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/config.yml b/SSI/loaded_beam/CalculiX-CalculiX/config.yml
deleted file mode 100755
index b811c08bc..000000000
--- a/SSI/loaded_beam/CalculiX-CalculiX/config.yml
+++ /dev/null
@@ -1,17 +0,0 @@
-participants:
-
- Calculix1:
- interfaces:
- - nodes-mesh: Calculix_Mesh1
- patch: surface
- read-data: [Displacements0]
- write-data: [Forces0]
-
- Calculix2:
- interfaces:
- - nodes-mesh: Calculix_Mesh2
- patch: surface
- read-data: [Forces0]
- write-data: [Displacements0]
-
-precice-config-file: ./precice-config.xml
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/precice-config.xml b/SSI/loaded_beam/CalculiX-CalculiX/precice-config.xml
deleted file mode 100755
index ae4e3f578..000000000
--- a/SSI/loaded_beam/CalculiX-CalculiX/precice-config.xml
+++ /dev/null
@@ -1,67 +0,0 @@
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/visualize.py b/SSI/loaded_beam/CalculiX-CalculiX/visualize.py
deleted file mode 100755
index c9d22e631..000000000
--- a/SSI/loaded_beam/CalculiX-CalculiX/visualize.py
+++ /dev/null
@@ -1,122 +0,0 @@
-#!/usr/bin/python
-
-"""
-Use this script to join the visual results (.frd files) of beam1 and beam2 and visualize them.
-"""
-
-import subprocess
-
-#### params ####
-
-# size of complete node sets
-nsize1 = 201
-nsize2 = 81
-nsizem = 261 # nsize1 + nsize2 - nsize_coupling_surface
-
-# time steps. set in precice-config.xml and .inp files
-nsteps = 50
-
-
-##################################################################
-def join_frd( frd1, frd2 ):
- """
- Append the nodes and elements from frd2 to those in frd1 and write the result in a new frd.
- """
- with open( frd1, "r" ) as f1, open( frd2, "r" ) as f2, open( "beam_full.frd" , "w" ) as fp:
-
- # copy frd header in new file
- for i in xrange(11):
- fp.write( f1.readline() )
- f2.readline()
-
- # node header (change number of nodes)
- line_f1 = f1.readline()
- line_f1 = line_f1[:33] + str(nsizem) + line_f1[36:]
- fp.write( line_f1 )
- f2.readline()
-
- # merging node lines. each iteration in the for uses a new line from frd2. lines in frd1 are advanced manually
- line_f1 = f1.readline()
- for line_f2 in iter( f2.readline, " -3\n" ):# -3 indicates end of line block
- # same node in both files (interface): write any (assuming their values are correct!!)
- if line_f1[:13] == line_f2[:13]:
- if line_f1[2] == "3":
- continue
- else:
- fp.write( line_f1 )
- line_f1 = f1.readline()
- # sorting lines according to node index
- elif line_f2 < line_f1:
- fp.write(line_f2)
- else:
- while(line_f2 > line_f1):
- fp.write( line_f1 )
- line_f1 = f1.readline()
-
- if line_f1[:13] != line_f2[:13]:
- fp.write( line_f2 )
-
- fp.write( " -3\n" )
-
- # element header (change number of elements)
- line_f1 = f1.readline()
- line_f1 = line_f1[:34] + "32" + line_f1[36:]
- fp.write( line_f1 )
- f2.readline()
-
- # merge element lines. assuming they are sorted and non-overlapping in frd1 and frd2
- for line_f1 in iter( f1.readline, " -3\n" ):
- fp.write( line_f1 )
- for line_f2 in iter( f2.readline, " -3\n" ):
- fp.write( line_f2 )
- fp.write( " -3\n" )
-
- # merging blocks of lines for each step
- for i in xrange( nsteps ):
- print "step", i+1
- # step header
- fp.write( f1.readline() )
- f2.readline()
- line_f1 = f1.readline()
- line_f1 = line_f1[:33] + str(nsizem) + line_f1[36:]
- fp.write( line_f1 )
- f2.readline()
- for j in xrange(5):
- fp.write( f1.readline() )
- f2.readline()
-
- line_f1 = f1.readline()
- for line_f2 in iter( f2.readline, " -3\n" ):# -3 indicates end of line block
- # same node in both files (interface): write any (assuming their values are correct!!)
- if line_f1[:13] == line_f2[:13]:
- if line_f1[2] == "3":
- continue
- else:
- # this is an interface node for both beams. write the mean of the values in beam1 and beam2
- mean_vals = [ ( float(x)+float(y) ) / 2. for x,y in zip( [line_f1[13:25], line_f1[25:37], line_f1[37:49]], [line_f2[13:25], line_f2[25:37], line_f2[37:49]] ) ]
- fp.writelines( line_f1[:13] + '{:12.5E}'.format(mean_vals[0])+'{:12.5E}'.format(mean_vals[1]) + '{:12.5E}'.format(mean_vals[2]) + '\n' )
- line_f1 = f1.readline()
- # sorting lines according to node index
- elif line_f2 < line_f1:
- fp.write( line_f2 )
- else:
- while( line_f2[:13] > line_f1[:13] ):
- fp.write( line_f1 )
- line_f1 = f1.readline()
-
- if line_f1[:13] != line_f2[:13]:
- fp.write( line_f2 )
- else:
- mean_vals = [ ( float(x)+float(y) )/2. for x,y in zip( [line_f1[13:25], line_f1[25:37], line_f1[37:49]], [line_f2[13:25], line_f2[25:37], line_f2[37:49]] ) ]
- fp.writelines( line_f1[:13] + '{:12.5E}'.format( mean_vals[0] )+ '{:12.5E}'.format( mean_vals[1] ) + '{:12.5E}'.format(mean_vals[2]) + '\n' )
- line_f1 = f1.readline()
-
- fp.write(" -3\n")
-
- fp.write("9999\n")#EOF
-
-
-########################## MAIN #################################
-
-join_frd( "beam1.frd", "beam2.frd" )
-subprocess.call(["cgx", "-b", "visualize.fbd"])
diff --git a/clean-all.sh b/clean-all.sh
new file mode 100755
index 000000000..0e5bc2e5c
--- /dev/null
+++ b/clean-all.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+echo "- Cleaning up all tutorials..."
+
+find . -maxdepth 2 -mindepth 2 -name clean-tutorial.sh -execdir sh -c './clean-tutorial.sh' \;
\ No newline at end of file
diff --git a/elastic-tube-1d/.gitignore b/elastic-tube-1d/.gitignore
new file mode 100644
index 000000000..584556938
--- /dev/null
+++ b/elastic-tube-1d/.gitignore
@@ -0,0 +1,11 @@
+fluid-cpp/build/
+fluid-cpp/output/*.vtk
+solid-cpp/build/
+fluid-python/__pycache__/
+fluid-python/output/*.vtk
+solid-python/__pycache__/
+
+*.o
+*.log
+*.json
+*.pyc
diff --git a/elastic-tube-1d/README.md b/elastic-tube-1d/README.md
new file mode 100644
index 000000000..064e514e1
--- /dev/null
+++ b/elastic-tube-1d/README.md
@@ -0,0 +1,126 @@
+---
+title: 1D Elastic Tube
+permalink: tutorials-elastic-tube-1d.html
+keywords: OpenFOAM, python
+summary: The 1D Elastic Tube is a FSI case, that consists of an internal flow in a flexible tube. The flow is unsteady and incompressible. This tutorial contains C++ and Python variants of the fluid and solid solvers. Running the simulation takes just 1-2 minutes.
+---
+
+
+## Setup
+
+We want to simulate the internal flow in a flexible tube as shown in the figure below (image from [1]).
+
+
+
+The flow is assumed to be incompressible flow and gravity is neglected. Due to the axisymmetry, the flow can be described using a quasi-two-dimensional continuity and momentum equations. The motivation and exact formulation of the equations that we consider can be found in [2].
+
+The following parameters have been chosen:
+- Length of the tube: L = 10
+- Inlet velocity: $$ v_{inlet} = 10 + 3 sin (10 \pi t) $$
+- Initial cross sectional area = 1
+- Initial velocity: v = 10
+- Initial pressure: p = 0
+- Fluid density: $$ \rho = 1 $$
+- Young modulus: E = 10000
+
+
+## Available solvers
+
+Both fluid and solid participant are supported in:
+
+* *C++*: An example solver using the intrinsic [C++ API of preCICE](couple-your-code-api.html). This solver also depends on LAPACK (e.g. on Ubuntu `sudo apt-get install liblapack-dev`)
+* *Python*: An example solver using the preCICE [Python bindings](installation-bindings-python.html). This solver also depends on the Python libraries `numpy scipy matplotlib vtk mpi4py`, which you can get from your system package manager or with `pip3 install --user `.
+
+
+### Building the C++ Solver
+
+In order to use the C++ solver, you first need to build the scripts `FluidSolver` and `SolidSolver`. Each script needs to be built separately.
+
+```
+cd fluid-cpp
+mkdir build && cd build
+cmake ..
+make all
+```
+
+```
+cd solid-cpp
+mkdir build && cd build
+cmake ..
+make all
+```
+
+Building can be skipped if you do not plan to use the C++ version.
+
+## Running the Simulation
+
+### C++
+
+Open two separate terminals and start each participant by calling the respective run script.
+
+```
+cd fluid-cpp
+./run.sh
+```
+and
+```
+cd solid-cpp
+./run.sh
+```
+
+The solvers use the parameters `N = 100`, `tau = 0.01`, `kappa = 100` by default and can be modified in the solver.
+
+### Python
+
+Open two separate terminals and start each participant by calling the respective run script. Only serial run is possible:
+
+```
+cd fluid-python
+./run.sh
+```
+and
+```
+cd solid-python
+./run.sh
+```
+Parameters such as `N` can be modified directly at the `FluidSolver.py` and at the `SolidSolver.py`. The parameters must be consistent between the different solvers and participants.
+
+**Optional:** Visualization and video output of the fluid participant can be triggered via the options `--enable-plot` and `--write-video` of `FluidSolver.py`. To generate .vtk files during execution, you need to add the flag `--write-vtk`.
+
+
+
+{% include warning.html content= "The C++ and Python solvers lead to different results. Please consider the Python results as the correct ones and refer to this [open issue](https://github.com/precice/tutorials/issues/195) for more insight. Contributions are particularly welcome here." %}
+
+## Post-processing
+
+The results from each simulation are stored in each `fluid-/output/` folder. You can visualize these VTK files using the provided `plot-diameter.sh` script
+```bash
+./plot-diameter.sh
+```
+which will try to visualize the results from both fluid cases, if available.
+
+This script calls the more flexible `plot-vtk.py` Python script, which you can use as
+```bash
+python3 plot-vtk.py /output/
+```
+Note the required arguments specifying which quantity to plot (`pressure`, `velocity` or `diameter`) and the name prefix of the target vtk files.
+
+For example, to plot the diameter of the fluid-python case using the default prefix for VTK files, `plot-diamter.sh` executes:
+```bash
+python3 plot-vtk.py diameter fluid-python/output/out_fluid_
+```
+
+
+## References
+
+[1] B. Gatzhammer. Efficient and Flexible Partitioned Simulation of Fluid-Structure Interactions. Technische Universitaet Muenchen, Fakultaet fuer Informatik, 2014.
+
+[2] J. Degroote, P. Bruggeman, R. Haelterman, and J. Vierendeels. Stability of a coupling technique for partitioned solvers in FSI applications. Computers & Structures, 2008.
+
+[3] M. Mehl, B. Uekermann, H. Bijl, D. Blom, B. Gatzhammer, and A. van Zuijlen.
+Parallel coupling numerics for partitioned fluid-structure interaction simulations. CAMWA, 2016.
+
+
+
+
+
diff --git a/elastic-tube-1d/clean-tutorial.sh b/elastic-tube-1d/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/elastic-tube-1d/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/elastic-tube-1d/fluid-cpp/CMakeLists.txt b/elastic-tube-1d/fluid-cpp/CMakeLists.txt
new file mode 100644
index 000000000..ca587d693
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/CMakeLists.txt
@@ -0,0 +1,27 @@
+cmake_minimum_required (VERSION 3.10)
+
+project(ElasticTube LANGUAGES CXX)
+set (CMAKE_CXX_STANDARD 11)
+
+if (NOT CMAKE_BUILD_TYPE AND NOT CMAKE_CONFIGURATION_TYPES)
+ set(CMAKE_BUILD_TYPE "Debug" CACHE STRING "Choose the type of build." FORCE)
+ # Set the possible values of build type for cmake-gui
+ set_property(CACHE CMAKE_BUILD_TYPE PROPERTY STRINGS
+ "Debug" "Release" "MinSizeRel" "RelWithDebInfo")
+endif()
+message(STATUS "Build configuration: " ${CMAKE_BUILD_TYPE})
+
+if ("${CMAKE_CXX_COMPILER_ID}" STREQUAL "GNU" OR "${CMAKE_CXX_COMPILER_ID}" STREQUAL "Clang")
+ set(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} -Wall -Wextra -Wno-unused-parameter")
+endif()
+
+find_package(precice REQUIRED CONFIG)
+find_package(LAPACK REQUIRED)
+
+add_executable(FluidSolver
+ src/FluidSolver.cpp
+ src/utilities.cpp
+ src/FluidComputeSolution.cpp)
+
+target_link_libraries(FluidSolver PRIVATE precice::precice)
+target_link_libraries(FluidSolver PRIVATE ${LAPACK_LIBRARIES} ${LAPACK_LINKER_FLAGS})
diff --git a/elastic-tube-1d/fluid-cpp/clean.sh b/elastic-tube-1d/fluid-cpp/clean.sh
new file mode 100755
index 000000000..ff2895ffa
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/clean.sh
@@ -0,0 +1,7 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+rm -rvf ./output/*.vtk
+clean_precice_logs .
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/dealii_output/.keepme b/elastic-tube-1d/fluid-cpp/output/.keepme
similarity index 100%
rename from FSI/flap_perp_2D/OpenFOAM-deal.II/Solid/dealii_output/.keepme
rename to elastic-tube-1d/fluid-cpp/output/.keepme
diff --git a/elastic-tube-1d/fluid-cpp/run.sh b/elastic-tube-1d/fluid-cpp/run.sh
new file mode 100755
index 000000000..e8c898b8e
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+./build/FluidSolver ../precice-config.xml
diff --git a/elastic-tube-1d/fluid-cpp/src/FluidComputeSolution.cpp b/elastic-tube-1d/fluid-cpp/src/FluidComputeSolution.cpp
new file mode 100644
index 000000000..10129c305
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/src/FluidComputeSolution.cpp
@@ -0,0 +1,217 @@
+#include "FluidComputeSolution.h"
+
+#include
+#include
+#include
+#include
+#include
+
+using std::sin;
+using std::sqrt;
+
+// Simplifies strided access on a 1d buffer
+template
+class StridedAccess {
+ public:
+ StridedAccess(T*first, int stride) : first(first), stride(stride) {};
+ // This accessor allows for row-major access
+ T& operator()(int i, int j) { return first[j*stride+i]; }
+ private:
+ T*first;
+ int stride;
+};
+
+extern "C" {
+void dgesv_(
+ int * n,
+ int * nrhs,
+ double *A,
+ int * lda,
+ int * ipiv,
+ double *b,
+ int * ldb,
+ int * info);
+}
+
+/* Function for fluid_nl i.e. non-linear */
+int fluidComputeSolutionSerial(
+ double const * const velocity_old,
+ double const * const pressure_old,
+ double const * const crossSectionLength_old,
+ double const * const crossSectionLength,
+ double t,
+ int N,
+ double kappa,
+ double tau,
+ double * velocity,
+ double * pressure)
+{
+ const double PI = 3.141592653589793;
+
+ /* fluid_nl Variables */
+ const double E = 10000;
+ // c_mk^2
+ const double c_mk2 = E / 2 * sqrt(PI);
+
+ const int chunkLength = N + 1;
+ std::copy(velocity_old, velocity_old + chunkLength, velocity);
+ std::copy(pressure_old, pressure_old + chunkLength, pressure);
+
+ // Used as Ax = b
+ // i.e. LHS*x = Res
+ std::vector Res(2 * N + 2);
+ std::vector LHS_buffer(std::pow(2*N + 2, 2));
+ StridedAccess LHS(LHS_buffer.data(), 2* N + 2);
+
+ /* LAPACK Variables */
+ int nlhs = (2 * N + 2);
+ int nrhs = 1;
+ std::vector ipiv(nlhs);
+
+ /* Stabilization Intensity */
+ const double alpha = 0.0; //(N * kappa * tau) / (N * tau + 1);
+ const double L = 10.0;
+ const double dx = L / kappa; // 1.0 / (N * kappa);
+
+ // k is the iteration counter
+ for(int k = 1; ; ++k) {
+ std::fill(Res.begin(), Res.end(), 0.0);
+
+ for (int i = 1; i < N; i++) {
+ /* Momentum */
+ Res[i] = (velocity_old[i] * crossSectionLength_old[i] - velocity[i] * crossSectionLength[i]) * dx / tau;
+
+ Res[i] += 0.25 * (- crossSectionLength[i + 1] * velocity[i] * velocity[i + 1]
+ - crossSectionLength[i] * velocity[i] * velocity[i + 1]);
+
+ Res[i] += 0.25 * (- crossSectionLength[i + 1] * velocity[i] * velocity[i]
+ - crossSectionLength[i] * velocity[i] * velocity[i]
+ + crossSectionLength[i] * velocity[i - 1] * velocity[i]
+ + crossSectionLength[i - 1] * velocity[i - 1] * velocity[i]);
+
+ Res[i] += 0.25 * (+ crossSectionLength[i - 1] * velocity[i - 1] * velocity[i - 1]
+ + crossSectionLength[i] * velocity[i - 1] * velocity[i - 1]);
+
+ Res[i] += 0.25*(+ crossSectionLength[i - 1] * pressure[i - 1]
+ + crossSectionLength[i] * pressure[i - 1]
+ - crossSectionLength[i - 1] * pressure[i]
+ + crossSectionLength[i + 1] * pressure[i]
+ - crossSectionLength[i] * pressure[i + 1]
+ - crossSectionLength[i + 1] * pressure[i + 1]);
+
+ /* Continuity */
+ Res[i + N + 1] = (crossSectionLength_old[i] - crossSectionLength[i]) * dx / tau;
+ Res[i + N + 1] += 0.25*(+ crossSectionLength[i - 1] * velocity[i - 1]
+ + crossSectionLength[i] * velocity[i - 1]
+ + crossSectionLength[i - 1] * velocity[i]
+ - crossSectionLength[i + 1] * velocity[i]
+ - crossSectionLength[i] * velocity[i + 1]
+ - crossSectionLength[i + 1] * velocity[i + 1]);
+
+ Res[i + N + 1] += alpha * (pressure[i - 1] - 2 * pressure[i] + pressure[i + 1]);
+ }
+
+ /* Boundary */
+
+ /* Velocity Inlet is prescribed */
+ const double u0 = 10.0;
+ const double ampl = 3.0;
+ const double frequency = 10.0;
+ const double t_shift = 0.0;
+ const double velocity_in = u0 + ampl * sin(frequency * (t + t_shift) * PI);
+ Res[0] = velocity_in - velocity[0];
+
+ /* Pressure Inlet is lineary interpolated */
+ Res[N + 1] = -pressure[0] + 2 * pressure[1] - pressure[2];
+
+ /* Velocity Outlet is lineary interpolated */
+ Res[N] = -velocity[N] + 2 * velocity[N - 1] - velocity[N - 2];
+
+ /* Pressure Outlet is "non-reflecting" */
+ const double tmp2 = sqrt(c_mk2 - pressure_old[N] / 2) - (velocity[N] - velocity_old[N]) / 4;
+ Res[2 * N + 1] = -pressure[N] + 2 * (c_mk2 - std::pow(tmp2, 2));
+
+ // compute norm of residual
+ const double norm_1 = std::sqrt(
+ std::inner_product(Res.begin(), Res.end(), Res.begin(), 0.0)
+ );
+
+ const double norm_2 = std::sqrt(
+ std::inner_product(pressure, pressure + chunkLength, pressure, 0.0) +
+ std::inner_product(velocity, velocity + chunkLength, velocity, 0.0)
+ );
+ const double norm = norm_1 / norm_2;
+
+ // NOTE tolerance is 1e-10 and max iterations is 1000 in python
+ if ((norm < 1e-15 && k > 1) || k > 50) {
+ std::cout << "Nonlinear Solver break, iterations: " << k << ", residual norm: " << norm << '\n';
+ break;
+ }
+
+ /* Initilizing the the LHS i.e. Left Hand Side */
+ std::fill(LHS_buffer.begin(), LHS_buffer.end(), 0.0);
+
+ for (int i = 1; i < N; i++) {
+ // Momentum, Velocity
+ LHS(i, i - 1) +=0.25*(-2 * crossSectionLength[i - 1] * velocity[i - 1]
+ -2 * crossSectionLength[i] * velocity[i - 1]
+ - crossSectionLength[i] * velocity[i]
+ - crossSectionLength[i - 1] * velocity[i]);
+
+ LHS(i, i) += crossSectionLength[i] * dx / tau;
+ LHS(i, i) += 0.25 * (+ crossSectionLength[i + 1] * velocity[i + 1]
+ + crossSectionLength[i] * velocity[i + 1]
+ +2 * crossSectionLength[i + 1] * velocity[i]
+ +2 * crossSectionLength[i] * velocity[i]
+ - crossSectionLength[i] * velocity[i - 1]
+ - crossSectionLength[i - 1] * velocity[i - 1]);
+ LHS(i, i + 1) += 0.25 * (+ crossSectionLength[i + 1] * velocity[i]
+ + crossSectionLength[i] * velocity[i]);
+
+ // Momentum, Pressure
+ LHS(i, N + 1 + i - 1) += -0.25 * crossSectionLength[i - 1] - 0.25 * crossSectionLength[i];
+ LHS(i, N + 1 + i) += 0.25 * crossSectionLength[i - 1] - 0.25 * crossSectionLength[i + 1];
+ LHS(i, N + 1 + i + 1) += 0.25 * crossSectionLength[i] + 0.25 * crossSectionLength[i + 1];
+
+ // Continuity, Velocity
+ LHS(i + N + 1, i - 1) += -0.25 * crossSectionLength[i - 1] - 0.25 * crossSectionLength[i];
+ LHS(i + N + 1, i) += -0.25 * crossSectionLength[i - 1] + 0.25 * crossSectionLength[i + 1];
+ LHS(i + N + 1, i + 1) += 0.25 * crossSectionLength[i] + 0.25 * crossSectionLength[i + 1];
+
+ // Continuity, Pressure
+ LHS(i + N + 1, N + 1 + i - 1) -= alpha;
+ LHS(i + N + 1, N + 1 + i) += 2 * alpha;
+ LHS(i + N + 1, N + 1 + i + 1) -= alpha;
+ }
+
+ /* Boundary */
+
+ // Velocity Inlet is prescribed
+ LHS(0, 0) = 1;
+ // Pressure Inlet is lineary interpolated
+ LHS(N + 1, N + 1) = 1;
+ LHS(N + 1, N + 2) = -2;
+ LHS(N + 1, N + 3) = 1;
+ // Velocity Outlet is lineary interpolated
+ LHS(N, N) = 1;
+ LHS(N, N - 1) = -2;
+ LHS(N, N - 2) = 1;
+ // Pressure Outlet is Non-Reflecting
+ LHS(2 * N + 1, 2 * N + 1) = 1;
+ LHS(2 * N + 1, N) = -(sqrt(c_mk2 - pressure_old[N] / 2.0) - (velocity[N] - velocity_old[N]) / 4.0);
+
+ /* LAPACK Function call to solve the linear system */
+ int info{0};
+ dgesv_(&nlhs, &nrhs, LHS_buffer.data(), &nlhs, ipiv.data(), Res.data(), &nlhs, &info);
+
+ if (info != 0) {
+ std::cerr << "Linear Solver not converged!, Info: " << info << '\n';
+ }
+
+ for (int i = 0; i <= N; i++) {
+ velocity[i] += Res[i];
+ pressure[i] += Res[i + N + 1];
+ }
+ }
+ return 0;
+}
diff --git a/elastic-tube-1d/fluid-cpp/src/FluidComputeSolution.h b/elastic-tube-1d/fluid-cpp/src/FluidComputeSolution.h
new file mode 100644
index 000000000..20c52c543
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/src/FluidComputeSolution.h
@@ -0,0 +1,15 @@
+#pragma once
+
+const double PI = 3.14159265359;
+
+int fluidComputeSolutionSerial(
+ double const * const velocity_old,
+ double const * const pressure_old,
+ double const * const crossSectionLength_old,
+ double const * const crossSectionLength,
+ double t,
+ int N,
+ double kappa,
+ double tau,
+ double * velocity,
+ double * pressure);
diff --git a/elastic-tube-1d/fluid-cpp/src/FluidSolver.cpp b/elastic-tube-1d/fluid-cpp/src/FluidSolver.cpp
new file mode 100644
index 000000000..676dfde94
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/src/FluidSolver.cpp
@@ -0,0 +1,152 @@
+#include "FluidComputeSolution.h"
+#include "utilities.h"
+
+#include
+#include
+#include
+#include "precice/SolverInterface.hpp"
+
+using namespace precice;
+using namespace precice::constants;
+
+int main(int argc, char **argv)
+{
+
+ std::cout << "Starting Fluid Solver..." << std::endl;
+ if (argc != 2) {
+ std::cout << std::endl;
+ std::cout << "Fluid: Usage: " << argv[0] << " " << std::endl;
+
+ return -1;
+ }
+
+ std::string configFileName(argv[1]);
+ int domainSize = 100; //N
+ int chunkLength = domainSize + 1;
+ const double kappa = 100;
+ const double L = 10.0; // tube length
+
+ const std::string solverName = "Fluid";
+
+ std::string outputFilePrefix = "./output/out_fluid"; //extra
+
+ SolverInterface interface(solverName, configFileName, 0, 1);
+ std::cout << "preCICE configured..." << std::endl;
+
+ const int dimensions = interface.getDimensions();
+ const int meshID = interface.getMeshID("Fluid-Nodes-Mesh");
+ const int pressureID = interface.getDataID("Pressure", meshID);
+ const int crossSectionLengthID = interface.getDataID("CrossSectionLength", meshID);
+
+ std::vector vertexIDs(chunkLength);
+
+ const double PI = 3.141592653589793;
+
+ const double r0 = 1 / sqrt(PI); // radius of the tube
+ const double a0 = std::pow(r0, 2) * PI; // cross sectional area
+ const double u0 = 10; // mean velocity
+ const double ampl = 3; // amplitude of varying velocity
+ const double frequency = 10; // frequency of variation
+ const double t_shift = 0; // temporal shift of variation
+ const double p0 = 0; // pressure at outlet
+ const double vel_in_0 = u0 + ampl * sin(frequency * (t_shift) * PI);
+
+ std::vector pressure(chunkLength, p0);
+ std::vector pressure_old(pressure);
+ std::vector crossSectionLength(chunkLength, a0);
+ std::vector crossSectionLength_old(crossSectionLength);
+ std::vector velocity(chunkLength, vel_in_0);
+ std::vector velocity_old(velocity);
+ std::vector grid(dimensions * chunkLength);
+
+ const double cellwidth =(L / domainSize) ;
+ for (int i = 0; i < chunkLength; i++) {
+ for (int d = 0; d < dimensions; d++) {
+ if (d == 0) {
+ grid[i * dimensions] = i * cellwidth;
+ } else {
+ grid[i * dimensions + d] = 0.0;
+ }
+ }
+ }
+
+ interface.setMeshVertices(meshID, chunkLength, grid.data(), vertexIDs.data());
+
+ std::cout << "Initialize preCICE..." << std::endl;
+ interface.initialize();
+
+ double t = 0.0;
+ double dt = 0.01;
+
+ if (interface.isActionRequired(actionWriteInitialData())) {
+ interface.writeBlockScalarData(pressureID, chunkLength, vertexIDs.data(), pressure.data());
+ interface.markActionFulfilled(actionWriteInitialData());
+ }
+
+ interface.initializeData();
+
+ if (interface.isReadDataAvailable()) {
+ interface.readBlockScalarData(crossSectionLengthID, chunkLength, vertexIDs.data(), crossSectionLength.data());
+ }
+
+ std::copy(crossSectionLength.begin(), crossSectionLength.end(), crossSectionLength_old.begin());
+
+ // initialize such that mass conservation is fulfilled
+ for(int i = 0; i < chunkLength; ++i) {
+ velocity_old[i] = vel_in_0 * crossSectionLength_old[0] / crossSectionLength_old[i];
+ }
+
+ int out_counter = 0;
+
+ while (interface.isCouplingOngoing()) {
+ if (interface.isActionRequired(actionWriteIterationCheckpoint())) {
+ interface.markActionFulfilled(actionWriteIterationCheckpoint());
+ }
+
+
+ if (interface.isReadDataAvailable()) {
+ interface.readBlockScalarData(crossSectionLengthID, chunkLength, vertexIDs.data(), crossSectionLength.data());
+ }
+
+ fluidComputeSolutionSerial(
+ // values from last time window
+ velocity_old.data(), pressure_old.data(), crossSectionLength_old.data(),
+ // last received crossSectionLength
+ crossSectionLength.data(),
+ t+dt, // used for inlet velocity
+ domainSize,
+ kappa,
+ dt, // tau
+ // resulting velocity pressure
+ velocity.data(),
+ pressure.data());
+
+ if (interface.isWriteDataRequired(dt)) {
+ interface.writeBlockScalarData(pressureID, chunkLength, vertexIDs.data(), pressure.data());
+ }
+
+ interface.advance(dt);
+
+ //interface.readBlockScalarData(crossSectionLengthID, chunkLength, vertexIDs.data(), crossSectionLength.data());
+ if (interface.isReadDataAvailable()) {
+ interface.readBlockScalarData(crossSectionLengthID, chunkLength, vertexIDs.data(), crossSectionLength.data());
+ }
+
+ if (interface.isActionRequired(actionReadIterationCheckpoint())) { // i.e. not yet converged
+ interface.markActionFulfilled(actionReadIterationCheckpoint());
+ } else {
+ t += dt;
+ write_vtk(t, out_counter, outputFilePrefix.c_str(), chunkLength, grid.data(), velocity.data(), pressure.data(), crossSectionLength.data());
+ for (int i = 0; i < chunkLength; i++) {
+ crossSectionLength_old[i] = crossSectionLength[i];
+ pressure_old[i] = pressure[i];
+ velocity_old[i] = velocity[i];
+ }
+ out_counter++;
+ }
+ }
+
+ std::cout << "Exiting FluidSolver" << std::endl;
+ interface.finalize();
+ return 0;
+}
diff --git a/elastic-tube-1d/fluid-cpp/src/utilities.cpp b/elastic-tube-1d/fluid-cpp/src/utilities.cpp
new file mode 100644
index 000000000..a96e3cb9e
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/src/utilities.cpp
@@ -0,0 +1,114 @@
+#include "utilities.h"
+#include
+#include
+#include
+#include
+#include
+#include
+#include
+#include
+
+/*
+ Function for solving the linear system
+ LAPACK is used DGESV computes the solution to a real system of linear equations
+ A * x = b,
+ where A is an N-by-N matrix and x and b are N-by-NRHS matrices.
+*/
+extern "C" {
+void dgesv_(
+ int * n,
+ int * nrhs,
+ double *A,
+ int * lda,
+ int * ipiv,
+ double *b,
+ int * ldb,
+ int * info);
+}
+
+void initializeWriting(std::ofstream &filestream)
+{
+ filestream.setf(std::ios::showpoint);
+ filestream.setf(std::ios::scientific);
+ filestream << std::setprecision(16);
+}
+
+void writeHeader(std::ostream &outFile)
+{
+ outFile << "# vtk DataFile Version 2.0" << std::endl
+ << std::endl
+ << "ASCII" << std::endl
+ << std::endl
+ << "DATASET UNSTRUCTURED_GRID" << std::endl
+ << std::endl;
+}
+
+void exportMesh(std::ofstream &outFile, int N_slices, double *grid)
+{
+ // Plot vertices
+ outFile << "POINTS " << N_slices << " float " << std::endl
+ << std::endl;
+
+ for (int i = 0; i < N_slices; i++) {
+ // read x,y from grid. Set z = 0
+ // Values are stored in grid in the following way: [x_0,y_0,x_1,y_1,...x_n-1,y_n-1]
+ double x = grid[2 * i + 0];
+ double y = grid[2 * i + 1];
+ double z = 0.0;
+ outFile << x << " " << y << " " << z << std::endl;
+ }
+ outFile << std::endl;
+}
+
+void exportVectorData(std::ofstream &outFile, int N_slices, double *data, const char *dataname)
+{
+ outFile << "VECTORS " << dataname << " float" << std::endl;
+
+ for (int i = 0; i < N_slices; i++) {
+ // Plot vertex data
+ // read x vector component from dataset. Set y,z = 0
+ // Values are stored in dataset in the following way: [vx_0,vx_1,...vx_n-1]
+ double vx = data[i];
+ double vy = 0.0;
+ double vz = 0.0;
+ outFile << vx << " " << vy << " " << vz << std::endl;
+ }
+
+ outFile << std::endl;
+}
+
+void exportScalarData(std::ofstream &outFile, int N_slices, double *data, std::string dataname)
+{
+ outFile << "SCALARS " << dataname << " float" << std::endl;
+ outFile << "LOOKUP_TABLE default" << std::endl;
+
+ for (int i = 0; i < N_slices; i++) {
+ // Plot vertex data
+ outFile << data[i] << std::endl;
+ }
+
+ outFile << std::endl;
+}
+
+void write_vtk(double t, int iteration, const char *filename_prefix, int N_slices, double *grid, double *velocity, double *pressure, double *diameter)
+{
+ std::stringstream filename_stream;
+ filename_stream << filename_prefix << "_" << iteration << ".vtk";
+ std::string filename = filename_stream.str();
+ printf("writing timestep at t=%f to %s\n", t, filename.c_str());
+
+ std::ofstream outstream(filename);
+
+ initializeWriting(outstream);
+ writeHeader(outstream);
+ exportMesh(outstream, N_slices, grid);
+
+ outstream << "POINT_DATA " << N_slices << std::endl;
+ outstream << std::endl;
+
+ exportVectorData(outstream, N_slices, velocity, "velocity");
+ exportScalarData(outstream, N_slices, pressure, "pressure");
+ exportScalarData(outstream, N_slices, diameter, "diameter");
+
+ outstream.close();
+}
diff --git a/elastic-tube-1d/fluid-cpp/src/utilities.h b/elastic-tube-1d/fluid-cpp/src/utilities.h
new file mode 100644
index 000000000..416ba690d
--- /dev/null
+++ b/elastic-tube-1d/fluid-cpp/src/utilities.h
@@ -0,0 +1,14 @@
+#ifndef FLUID_NL_H_
+#define FLUID_NL_H_
+#include
+
+void write_vtk(double t,
+ int iteration,
+ const char *filename_prefix,
+ int N_slices,
+ double * grid,
+ double * velocity,
+ double * pressure,
+ double * diameter);
+
+#endif
diff --git a/elastic-tube-1d/fluid-python/FluidSolver.py b/elastic-tube-1d/fluid-python/FluidSolver.py
new file mode 100644
index 000000000..94bfe6c50
--- /dev/null
+++ b/elastic-tube-1d/fluid-python/FluidSolver.py
@@ -0,0 +1,174 @@
+from __future__ import division, print_function
+import os
+import sys
+import argparse
+import outputConfiguration as config
+from thetaScheme import perform_partitioned_implicit_trapezoidal_rule_step, perform_partitioned_implicit_euler_step
+import numpy as np
+import tubePlotting
+
+import matplotlib.pyplot as plt
+import matplotlib.animation as manimation
+
+from output import writeOutputToVTK
+
+import precice
+from precice import *
+
+parser = argparse.ArgumentParser()
+parser.add_argument("configurationFileName", help="Name of the xml precice configuration file.",
+ nargs='?', type=str, default="../precice-config.xml")
+parser.add_argument(
+ "--write-vtk", help="Save vtk files of each timestep in the 'VTK' folder.", action='store_true')
+parser.add_argument(
+ "--enable-plot", help="Show a continuously updated plot of the tube while simulating.", action='store_true')
+parser.add_argument("--write-video", help="Save a video of the simulation as 'writer_test.mp4'. \
+ NOTE: This requires 'enable_plot' to be active!", action='store_true')
+
+try:
+ args = parser.parse_args()
+except SystemExit:
+ print("")
+ print("Did you forget adding the precice configuration file as an argument?")
+ print("Try '$ python FluidSolver.py precice-config.xml'")
+ quit()
+
+output_mode = config.OutputModes.VTK if args.write_vtk else config.OutputModes.OFF
+plotting_mode = config.PlottingModes.VIDEO if args.enable_plot else config.PlottingModes.OFF
+if args.write_video and not args.enable_plot:
+ print("")
+ print("To create a video it is required to enable plotting for this run.")
+ print("Please supply both the '--enable-plot' and '--write-video' flags.")
+ quit()
+writeVideoToFile = True if args.write_video else False
+
+print("Starting Fluid Solver...")
+
+configFileName = args.configurationFileName
+
+# physical properties of the tube
+r0 = 1 / np.sqrt(np.pi) # radius of the tube
+a0 = r0**2 * np.pi # cross sectional area
+u0 = 10 # mean velocity
+ampl = 3 # amplitude of varying velocity
+frequency = 10 # frequency of variation
+t_shift = 0 # temporal shift of variation
+p0 = 0 # pressure at outlet
+kappa = 100
+
+
+def velocity_in(t): return u0 + ampl * np.sin(frequency *
+ (t + t_shift) * np.pi) # inflow velocity
+
+
+L = 10 # length of tube/simulation domain
+N = 100
+dx = L / kappa
+# helper function to create constant cross section
+
+
+def crossSection0(N):
+ return a0 * np.ones(N + 1)
+
+
+print("N: " + str(N))
+
+solverName = "Fluid"
+
+print("Configure preCICE...")
+interface = precice.Interface(solverName, configFileName, 0, 1)
+print("preCICE configured...")
+
+dimensions = interface.get_dimensions()
+
+velocity = velocity_in(0) * np.ones(N + 1)
+velocity_old = velocity_in(0) * np.ones(N + 1)
+pressure = p0 * np.ones(N + 1)
+pressure_old = p0 * np.ones(N + 1)
+crossSectionLength = a0 * np.ones(N + 1)
+crossSectionLength_old = a0 * np.ones(N + 1)
+
+
+if plotting_mode == config.PlottingModes.VIDEO:
+ fig, ax = plt.subplots(1)
+ if writeVideoToFile:
+ FFMpegWriter = manimation.writers['imagemagick']
+ metadata = dict(title='PulseTube')
+ writer = FFMpegWriter(fps=15, metadata=metadata)
+ writer.setup(fig, "writer_test.mp4", 100)
+
+meshID = interface.get_mesh_id("Fluid-Nodes-Mesh")
+crossSectionLengthID = interface.get_data_id("CrossSectionLength", meshID)
+pressureID = interface.get_data_id("Pressure", meshID)
+
+vertexIDs = np.zeros(N + 1)
+grid = np.zeros([N + 1, dimensions])
+
+grid[:, 0] = np.linspace(0, L, N + 1) # x component
+grid[:, 1] = 0 # y component, leave blank
+
+vertexIDs = interface.set_mesh_vertices(meshID, grid)
+
+t = 0
+precice_dt = 0.01
+
+print("Fluid: init precice...")
+# preCICE defines timestep size of solver via precice-config.xml
+interface.initialize()
+
+if interface.is_action_required(action_write_initial_data()):
+ interface.write_block_scalar_data(pressureID, vertexIDs, pressure)
+ interface.mark_action_fulfilled(action_write_initial_data())
+
+interface.initialize_data()
+
+if interface.is_read_data_available():
+ crossSectionLength = interface.read_block_scalar_data(
+ crossSectionLengthID, vertexIDs)
+
+crossSectionLength_old = np.copy(crossSectionLength)
+# initialize such that mass conservation is fulfilled
+velocity_old = velocity_in(
+ 0) * crossSectionLength_old[0] * np.ones(N + 1) / crossSectionLength_old
+
+print(crossSectionLength_old)
+
+time_it = 0
+while interface.is_coupling_ongoing():
+ # When an implicit coupling scheme is used, checkpointing is required
+ if interface.is_action_required(action_write_iteration_checkpoint()):
+ interface.mark_action_fulfilled(action_write_iteration_checkpoint())
+
+ velocity, pressure, success = perform_partitioned_implicit_euler_step(
+ velocity_old, pressure_old, crossSectionLength_old, crossSectionLength, dx, precice_dt, velocity_in(
+ t + precice_dt), custom_coupling=True)
+ interface.write_block_scalar_data(pressureID, vertexIDs, pressure)
+ interface.advance(precice_dt)
+ crossSectionLength = interface.read_block_scalar_data(
+ crossSectionLengthID, vertexIDs)
+
+ # i.e. not yet converged
+ if interface.is_action_required(action_read_iteration_checkpoint()):
+ interface.mark_action_fulfilled(action_read_iteration_checkpoint())
+ else: # converged, timestep complete
+ t += precice_dt
+ if plotting_mode is config.PlottingModes.VIDEO:
+ tubePlotting.doPlotting(
+ ax, crossSectionLength_old, velocity_old, pressure_old, dx, t)
+ if writeVideoToFile:
+ writer.grab_frame()
+ ax.cla()
+ velocity_old = np.copy(velocity)
+ pressure_old = np.copy(pressure)
+ crossSectionLength_old = np.copy(crossSectionLength)
+ if output_mode is config.OutputModes.VTK:
+ writeOutputToVTK(time_it, "out_fluid_", dx, datanames=["velocity", "pressure", "diameter"], data=[
+ velocity_old, pressure_old, crossSectionLength_old])
+ time_it += 1
+
+print("Exiting FluidSolver")
+
+if plotting_mode is config.PlottingModes.VIDEO and writeVideoToFile:
+ writer.finish()
+
+interface.finalize()
diff --git a/elastic-tube-1d/fluid-python/clean.sh b/elastic-tube-1d/fluid-python/clean.sh
new file mode 100755
index 000000000..ff2895ffa
--- /dev/null
+++ b/elastic-tube-1d/fluid-python/clean.sh
@@ -0,0 +1,7 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+rm -rvf ./output/*.vtk
+clean_precice_logs .
diff --git a/elastic-tube-1d/fluid-python/output.py b/elastic-tube-1d/fluid-python/output.py
new file mode 100644
index 000000000..3a6c98ac3
--- /dev/null
+++ b/elastic-tube-1d/fluid-python/output.py
@@ -0,0 +1,76 @@
+import os
+
+
+def writeOutputToVTK(time, name, dx, data, datanames):
+
+ if not isinstance(data, list):
+ data = list(data)
+ if not isinstance(datanames, list):
+ datanames = list(datanames)
+
+ n_datasets = data.__len__()
+ assert n_datasets == datanames.__len__()
+
+ outpath = os.path.join(os.getcwd(), './output')
+
+ if not os.path.exists(outpath):
+ os.mkdir(outpath)
+
+ filename = name + str(time) + ".vtk"
+ filepath = os.path.join(outpath, filename)
+
+ i = 0
+
+ f = open(filepath, 'w')
+
+ f.write("# vtk DataFile Version 2.0")
+ f.write("\n")
+ f.write("\n")
+
+ f.write("ASCII")
+ f.write("\n")
+ f.write("\n")
+
+ f.write("DATASET UNSTRUCTURED_GRID")
+ f.write("\n")
+ f.write("\n")
+
+ f.write("POINTS ")
+ f.write(str(len(data[i])))
+ f.write(" float")
+ f.write("\n")
+ f.write("\n")
+
+ for k in range(len(data[i])):
+ f.write(str("{:.16e}".format(0.0 + k * dx)))
+ f.write(" 0.0000000000000000e+00 0.0000000000000000e+00")
+ f.write("\n")
+ f.write("\n")
+
+ f.write("POINT_DATA ")
+ f.write(str(len(data[i])))
+ f.write("\n")
+ f.write("\n")
+
+ for dataname in datanames:
+
+ if (i == 0):
+ f.write("VECTORS ")
+ else:
+ f.write("SCALARS ")
+
+ f.write(dataname)
+ f.write(" float")
+ f.write("\n")
+ if (i != 0):
+ f.write("LOOKUP_TABLE default")
+ f.write("\n")
+ for element in data[i]:
+ f.write(str("{:.16e}".format(element)))
+ if (i == 0):
+ f.write(" 0.0000000000000000e+00 0.0000000000000000e+00")
+ f.write("\n")
+ f.write("\n")
+ f.write("\n")
+ i = i + 1
+ f.close()
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/OpenFOAM.foam b/elastic-tube-1d/fluid-python/output/.keepme
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/OpenFOAM.foam
rename to elastic-tube-1d/fluid-python/output/.keepme
diff --git a/elastic-tube-1d/fluid-python/outputConfiguration.py b/elastic-tube-1d/fluid-python/outputConfiguration.py
new file mode 100644
index 000000000..f00ad47f6
--- /dev/null
+++ b/elastic-tube-1d/fluid-python/outputConfiguration.py
@@ -0,0 +1,13 @@
+from __future__ import division
+from enum import Enum
+
+
+class PlottingModes(Enum):
+ OFF = 0 # no plotting over time
+ VIDEO = 1 # create a video
+ DEBUG = 2 # provide a debug plot over time of the simulation
+
+
+class OutputModes(Enum):
+ OFF = 0 # no plotting over time
+ VTK = 1 # produce VTK output
diff --git a/elastic-tube-1d/fluid-python/run.sh b/elastic-tube-1d/fluid-python/run.sh
new file mode 100755
index 000000000..66e1e828a
--- /dev/null
+++ b/elastic-tube-1d/fluid-python/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+python3 ./FluidSolver.py ../precice-config.xml --write-vtk
diff --git a/elastic-tube-1d/fluid-python/thetaScheme.py b/elastic-tube-1d/fluid-python/thetaScheme.py
new file mode 100644
index 000000000..c6566f662
--- /dev/null
+++ b/elastic-tube-1d/fluid-python/thetaScheme.py
@@ -0,0 +1,202 @@
+# based on https://github.com/precice/elastictube1d and
+# [1] J. Degroote, P. Bruggeman, R. Haelterman, and J. Vierendeels. Stability of a coupling technique for partitioned solvers in FSI applications. Computers & Structures, 2008.
+# for time integration details see
+# [2] Gresho, P. M., & Sani, R. L. (2000). Incompressible Flow and the Finite Element Method, Isothermal Laminar Flow. John Wiley & Sons. Retrieved from http://books.google.de/books?id=m_tQAAAAMAAJ
+
+from __future__ import division, print_function
+import numpy as np
+
+
+def perform_partitioned_theta_scheme_step(velocity0, pressure0, crossSection0, crossSection1, dx, tau, velocity_in,
+ custom_coupling, theta=1):
+
+ k = 0
+
+ # initial guess for Newtons method
+ pressure1 = np.copy(pressure0)
+ velocity1 = np.copy(velocity0)
+
+ crossSection_couple = 2 * [None]
+ if custom_coupling:
+ # set cross sections corresponding to point in time
+ crossSection_couple[0] = crossSection0
+ crossSection_couple[1] = crossSection1
+ else:
+ # set both cross sections equal to input -> depending on input: implicit or explicit coupling
+ crossSection_couple[0] = crossSection1
+ crossSection_couple[1] = crossSection1
+
+ N = pressure0.shape[0] - 1
+
+ alpha = 0
+ success = True
+
+ E = 10000 # elasticity module
+ c_mk = np.sqrt(E / 2 * np.sqrt(np.pi)) # wave speed
+
+ while success: # perform Newton iterations to solve nonlinear system of equations
+
+ # compute residual
+ res = np.zeros(2 * N + 2)
+
+ for i in range(1, N):
+ # Momentum
+ res[i] = (velocity0[i] * crossSection0[i] -
+ velocity1[i] * crossSection1[i]) * dx / tau
+
+ res[i] += .25 * theta * (- crossSection_couple[1][i + 1] * velocity1[i] * velocity1[i + 1]
+ - crossSection_couple[1][i] * velocity1[i] * velocity1[i + 1])
+ res[i] += .25 * (1 - theta) * (- crossSection_couple[0][i + 1] * velocity0[i] * velocity0[i + 1]
+ - crossSection_couple[0][i] * velocity0[i] * velocity0[i + 1])
+
+ res[i] += .25 * theta * (- crossSection_couple[1][i + 1] * velocity1[i] * velocity1[i]
+ - crossSection_couple[1][i] * velocity1[i] * velocity1[i]
+ + crossSection_couple[1][i] * velocity1[i - 1] * velocity1[i]
+ + crossSection_couple[1][i - 1] * velocity1[i - 1] * velocity1[i])
+ res[i] += .25 * (1 - theta) * (- crossSection_couple[0][i + 1] * velocity0[i] * velocity0[i]
+ - crossSection_couple[0][i] * velocity0[i] * velocity0[i]
+ + crossSection_couple[0][i] * velocity0[i - 1] * velocity0[i]
+ + crossSection_couple[0][i - 1] * velocity0[i - 1] * velocity0[i])
+
+ res[i] += .25 * theta * (+ crossSection_couple[1][i - 1] * velocity1[i - 1] * velocity1[i - 1]
+ + crossSection_couple[1][i] * velocity1[i - 1] * velocity1[i - 1])
+ res[i] += .25 * (1 - theta) * (+ crossSection_couple[0][i - 1] * velocity0[i - 1] * velocity0[i - 1]
+ + crossSection_couple[0][i] * velocity0[i - 1] * velocity0[i - 1])
+
+ res[i] += .25 * theta * (+ crossSection_couple[1][i - 1] * pressure1[i - 1]
+ + crossSection_couple[1][i] * pressure1[i - 1]
+ - crossSection_couple[1][i - 1] * pressure1[i]
+ + crossSection_couple[1][i + 1] * pressure1[i]
+ - crossSection_couple[1][i] * pressure1[i + 1]
+ - crossSection_couple[1][i + 1] * pressure1[i + 1])
+ res[i] += .25 * (1 - theta) * (+ crossSection_couple[0][i - 1] * pressure0[i - 1]
+ + crossSection_couple[0][i] * pressure0[i - 1]
+ - crossSection_couple[0][i - 1] * pressure0[i]
+ + crossSection_couple[0][i + 1] * pressure0[i]
+ - crossSection_couple[0][i] * pressure0[i + 1]
+ - crossSection_couple[0][i + 1] * pressure0[i + 1])
+
+ # Continuity (we only care about values at n+1, see [2],p.737,eq.(3.16-25))
+ res[i + N + 1] = (crossSection0[i] - crossSection1[i]) * dx / tau
+ res[i + N + 1] += .25 * theta * (+ crossSection_couple[1][i - 1] * velocity1[i - 1]
+ + crossSection_couple[1][i] * velocity1[i - 1]
+ + crossSection_couple[1][i - 1] * velocity1[i]
+ - crossSection_couple[1][i + 1] * velocity1[i]
+ - crossSection_couple[1][i] * velocity1[i + 1]
+ - crossSection_couple[1][i + 1] * velocity1[i + 1])
+ res[i + N + 1] += .25 * (1 - theta) * (+ crossSection_couple[0][i - 1] * velocity0[i - 1]
+ + crossSection_couple[0][i] * velocity0[i - 1]
+ + crossSection_couple[0][i - 1] * velocity0[i]
+ - crossSection_couple[0][i + 1] * velocity0[i]
+ - crossSection_couple[0][i] * velocity0[i + 1]
+ - crossSection_couple[0][i + 1] * velocity0[i + 1])
+ res[i + N + 1] += alpha * theta * (pressure1[i - 1] - 2 * pressure1[i] + pressure1[i + 1])
+
+ # Boundary
+
+ # Velocity Inlet is prescribed
+ res[0] = velocity_in - velocity1[0]
+
+ # Pressure Inlet is lineary interpolated
+ res[N + 1] = -pressure1[0] + 2 * pressure1[1] - pressure1[2]
+
+ # Velocity Outlet is lineary interpolated
+ res[N] = -velocity1[-1] + 2 * velocity1[-2] - velocity1[-3]
+
+ # Pressure Outlet is "non-reflecting"
+ tmp2 = np.sqrt(c_mk ** 2 - pressure0[-1] / 2) - (velocity1[-1] - velocity0[-1]) / 4
+ res[2 * N + 1] = -pressure1[-1] + 2 * (c_mk ** 2 - tmp2 * tmp2)
+
+ k += 1 # Iteration Count
+
+ # compute relative norm of residual
+ norm_1 = np.sqrt(res.dot(res))
+ norm_2 = np.sqrt(pressure1.dot(pressure1) + velocity1.dot(velocity1))
+ norm = norm_1 / norm_2
+
+ if norm < 1e-10 and k > 1:
+ break # Nonlinear Solver success
+ elif k > 1000:
+ print(
+ "Nonlinear Solver break, iterations: %i, residual norm: %e\n" % (k, norm))
+ velocity1[:] = np.nan
+ pressure1[:] = np.nan
+ success = False
+ break
+ # else:
+ # perform another iteration of newton's method
+
+ # compute Jacobian for Newton's method
+ system = np.zeros([N + N + 2, N + N + 2])
+
+ for i in range(1, N):
+ # Momentum, Velocity see [1] eq. (13b)
+ system[i][i - 1] += .25 * theta * (- 2 * crossSection_couple[1][i - 1] * velocity1[i - 1]
+ - 2 * crossSection_couple[1][i] * velocity1[i - 1]
+ - crossSection_couple[1][i] * velocity1[i]
+ - crossSection_couple[1][i - 1] * velocity1[i])
+ system[i][i] += crossSection1[i] * dx / tau
+ system[i][i] += .25 * theta * (+ crossSection_couple[1][i + 1] * velocity1[i + 1]
+ + crossSection_couple[1][i] * velocity1[i + 1]
+ + crossSection_couple[1][i + 1] * velocity1[i] * 2
+ + crossSection_couple[1][i] * velocity1[i] * 2
+ - crossSection_couple[1][i] * velocity1[i - 1]
+ - crossSection_couple[1][i - 1] * velocity1[i - 1])
+ system[i][i + 1] += .25 * theta * (crossSection_couple[1][i + 1] * velocity1[i]
+ + crossSection_couple[1][i] * velocity1[i])
+
+ # Momentum, Pressure see [1] eq. (13b)
+ system[i][N + 1 + i - 1] += .25 * theta * (- crossSection_couple[1][i - 1] - crossSection_couple[1][i])
+ system[i][N + 1 + i] += .25 * theta * (+ crossSection_couple[1][i - 1] - crossSection_couple[1][i + 1])
+ system[i][N + 1 + i + 1] += .25 * theta * (+ crossSection_couple[1][i] + crossSection_couple[1][i + 1])
+
+ # Continuity, Velocity see [1] eq. (13a)
+ system[i + N + 1][i - 1] += .25 * theta * (- crossSection_couple[1][i - 1] - crossSection_couple[1][i])
+ system[i + N + 1][i] += .25 * theta * (- crossSection_couple[1][i - 1] + crossSection_couple[1][i + 1])
+ system[i + N + 1][i + 1] += .25 * theta * (+ crossSection_couple[1][i] + crossSection_couple[1][i + 1])
+
+ # Continuity, Pressure see [1] eq. (13a)
+ system[i + N + 1][N + 1 + i - 1] += - alpha * theta
+ system[i + N + 1][N + 1 + i] += 2 * alpha * theta
+ system[i + N + 1][N + 1 + i + 1] += - alpha * theta
+
+ # Velocity Inlet is prescribed
+ system[0][0] = 1
+ # Pressure Inlet is linearly interpolated [1] eq. (14a)
+ system[N + 1][N + 1] = 1
+ system[N + 1][N + 2] = -2
+ system[N + 1][N + 3] = 1
+ # Velocity Outlet is linearly interpolated [1] eq. (14b)
+ system[N][N] = 1
+ system[N][N - 1] = -2
+ system[N][N - 2] = 1
+
+ # Pressure Outlet is Non-Reflecting [1] eq. (15)
+ system[2 * N + 1][2 * N + 1] = 1
+ system[2 * N + 1][N] = -(np.sqrt(c_mk ** 2 - pressure0[-1] / 2) - (velocity1[-1] - velocity0[-1]) / 4)
+
+ try:
+ solution = np.linalg.solve(system, res)
+ except np.linalg.LinAlgError:
+ print("LINALGERROR! SINGULAR MATRIX")
+ velocity1[:] = np.nan
+ pressure1[:] = np.nan
+ success = False
+ break
+
+ velocity1 += solution[:N + 1]
+ pressure1 += solution[N + 1:]
+
+ return velocity1, pressure1, success
+
+
+def perform_partitioned_implicit_euler_step(velocity0, pressure0, crossSection0, crossSection1, dx, tau,
+ velocity_in, custom_coupling):
+ return perform_partitioned_theta_scheme_step(velocity0, pressure0, crossSection0, crossSection1, dx, tau,
+ velocity_in, custom_coupling=False, theta=1)
+
+
+def perform_partitioned_implicit_trapezoidal_rule_step(velocity0, pressure0, crossSection0, crossSection1, dx, tau,
+ velocity_in, custom_coupling):
+ return perform_partitioned_theta_scheme_step(velocity0, pressure0, crossSection0, crossSection1, dx, tau,
+ velocity_in, custom_coupling, theta=.5)
diff --git a/elastic-tube-1d/fluid-python/tubePlotting.py b/elastic-tube-1d/fluid-python/tubePlotting.py
new file mode 100644
index 000000000..6a82ffa6d
--- /dev/null
+++ b/elastic-tube-1d/fluid-python/tubePlotting.py
@@ -0,0 +1,50 @@
+import matplotlib.pyplot as plt
+from matplotlib.patches import Rectangle
+import numpy as np
+
+scaling_factor = 50
+r0 = 1 / np.sqrt(np.pi)
+
+
+def plotTube(ax, crossSection, velocity, pressure, dx, t):
+
+ radius0 = np.sqrt(crossSection / np.pi)
+ N = velocity.shape[0]
+ u0 = 10
+ ampl = 3
+
+ ax.plot(np.arange(N) * dx, r0 + (radius0 - r0) * scaling_factor, 'k')
+ ax.plot(np.arange(N) * dx, -(r0 + (radius0 - r0) * scaling_factor), 'k')
+ iii = 0
+ rects = []
+ map = plt.get_cmap('RdBu')
+ for x in np.arange(N) * dx:
+ dy = (r0 + (radius0[iii] - r0) * scaling_factor)
+ rect = Rectangle((x - .5 * dx, -dy), dx, 2 * dy,
+ color=map((velocity[iii] + u0) / ampl))
+ ax.add_patch(rect)
+ iii += 1
+ rects.append(rect)
+
+ # plt.quiver(np.arange(N+1)*dx,np.zeros_like(velocity),velocity,np.zeros_like(velocity))
+ # plt.imshow(np.vstack((velocity,velocity,velocity,velocity)),origin="lower")
+ # plt.imshow(np.vstack((velocity,velocity)),origin="upper")
+ ax.set_ylim([-2, 2])
+
+
+def plotVar(ax, crossSection, dx, t):
+ radius0 = np.sqrt(crossSection / np.pi)
+ radius_mean = np.mean(np.sqrt(crossSection / np.pi))
+ N = crossSection.shape[0]
+ plt.plot(np.arange(N) * dx, (radius_mean - radius0) * scaling_factor)
+ lim = np.max(np.abs(radius0 - radius_mean))
+ borders = 10**0
+ ax.set_ylim([-borders, +borders])
+
+
+def doPlotting(ax, crossSection0, velocity0, pressure0, dx, t):
+ plotTube(ax, crossSection0, velocity0, pressure0, dx, t)
+ #plotVar(ax[1], crossSection0, dx, t)
+ plt.title(t)
+ plt.pause(0.1)
+ # ax[1].cla()
diff --git a/elastic-tube-1d/images/tutorials-elastic-tube-1d-animation.gif b/elastic-tube-1d/images/tutorials-elastic-tube-1d-animation.gif
new file mode 100644
index 000000000..e1dfc0a21
Binary files /dev/null and b/elastic-tube-1d/images/tutorials-elastic-tube-1d-animation.gif differ
diff --git a/elastic-tube-1d/images/tutorials-elastic-tube-1d-diameter.png b/elastic-tube-1d/images/tutorials-elastic-tube-1d-diameter.png
new file mode 100644
index 000000000..4cc152a72
Binary files /dev/null and b/elastic-tube-1d/images/tutorials-elastic-tube-1d-diameter.png differ
diff --git a/elastic-tube-1d/images/tutorials-elastic-tube-1d-setup.png b/elastic-tube-1d/images/tutorials-elastic-tube-1d-setup.png
new file mode 100644
index 000000000..9a4a7c475
Binary files /dev/null and b/elastic-tube-1d/images/tutorials-elastic-tube-1d-setup.png differ
diff --git a/elastic-tube-1d/plot-diameter.sh b/elastic-tube-1d/plot-diameter.sh
new file mode 100755
index 000000000..6bc02f916
--- /dev/null
+++ b/elastic-tube-1d/plot-diameter.sh
@@ -0,0 +1,16 @@
+#!/bin/sh
+set -e -u
+
+# Plot diameter from fluid-cpp
+if [ -d "./fluid-cpp/output/" ]; then
+ python3 plot-vtk.py diameter fluid-cpp/output/out_fluid_ &
+else
+ echo "No results to plot from fluid-cpp."
+fi
+
+# Plot diameter from fluid-python
+if [ -d "./fluid-python/output/" ]; then
+ python3 plot-vtk.py diameter fluid-python/output/out_fluid_ &
+else
+ echo "No results to plot from fluid-python."
+fi
diff --git a/elastic-tube-1d/plot-vtk.py b/elastic-tube-1d/plot-vtk.py
new file mode 100644
index 000000000..758a20986
--- /dev/null
+++ b/elastic-tube-1d/plot-vtk.py
@@ -0,0 +1,73 @@
+#!/usr/bin/python
+
+import vtk
+import numpy as np
+import os
+import sys
+import matplotlib.pyplot as plt
+from mpl_toolkits.mplot3d import Axes3D
+
+T = 100 # number of timesteps performed
+
+arrayname = sys.argv[1] # Which dataset should be plotted?
+data_path = sys.argv[2] # Where is the data?
+
+
+def file_name_generator(id): return data_path + str(id) + ".vtk"
+
+
+print("reading data from array with name = %s" % arrayname)
+print("parsing datasets named %s*.vtk" % data_path)
+
+values_for_all_t = T * [None]
+
+
+for t in range(T):
+
+ # read the vtk file as an unstructured grid
+ reader = vtk.vtkUnstructuredGridReader()
+ reader.SetFileName(file_name_generator(t))
+ reader.ReadAllVectorsOn()
+ reader.ReadAllScalarsOn()
+ reader.Update()
+
+ # parse the data
+ grid = reader.GetOutput()
+ point_data = grid.GetPointData().GetArray(arrayname)
+ points = grid.GetPoints()
+ N = grid.GetNumberOfPoints() # How many gridpoints do exist?
+
+ if point_data is None: # check if array exists in dataset
+ print("array with name %s does not exist!" % arrayname)
+ print("exiting.")
+ quit()
+
+ value_at_t = []
+ spatial_mesh = []
+
+ n = point_data.GetNumberOfComponents()
+
+ for i in range(N): # parse data from vtk array into list
+
+ x, y, z = grid.GetPoint(i) # read coordinates of point
+ spatial_mesh += [x] # only store x component
+
+ v = np.zeros(n) # initialize empty butter array
+ point_data.GetTuple(i, v) # read value into v
+ value_at_t += [np.linalg.norm(v)]
+
+ values_for_all_t[t] = value_at_t
+
+
+values_for_all_t = np.array(values_for_all_t)
+
+fig = plt.figure()
+ax = fig.add_subplot(111, projection='3d')
+X, Y = np.meshgrid(spatial_mesh, range(T))
+
+# uncomment depending on what quantity you want to plot
+ax.plot_surface(X, Y, values_for_all_t, cmap='viridis', edgecolor='black')
+plt.xlabel("space")
+plt.ylabel("time")
+plt.title(arrayname + " from " + data_path + "*.vtk")
+plt.show()
diff --git a/elastic-tube-1d/precice-config.xml b/elastic-tube-1d/precice-config.xml
new file mode 100644
index 000000000..581327626
--- /dev/null
+++ b/elastic-tube-1d/precice-config.xml
@@ -0,0 +1,73 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/elastic-tube-1d/solid-cpp/CMakeLists.txt b/elastic-tube-1d/solid-cpp/CMakeLists.txt
new file mode 100644
index 000000000..e5a8ee5d1
--- /dev/null
+++ b/elastic-tube-1d/solid-cpp/CMakeLists.txt
@@ -0,0 +1,24 @@
+cmake_minimum_required (VERSION 3.10)
+
+project(ElasticTube LANGUAGES CXX)
+set (CMAKE_CXX_STANDARD 11)
+
+if (NOT CMAKE_BUILD_TYPE AND NOT CMAKE_CONFIGURATION_TYPES)
+ set(CMAKE_BUILD_TYPE "Debug" CACHE STRING "Choose the type of build." FORCE)
+ # Set the possible values of build type for cmake-gui
+ set_property(CACHE CMAKE_BUILD_TYPE PROPERTY STRINGS
+ "Debug" "Release" "MinSizeRel" "RelWithDebInfo")
+endif()
+message(STATUS "Build configuration: " ${CMAKE_BUILD_TYPE})
+
+if ("${CMAKE_CXX_COMPILER_ID}" STREQUAL "GNU" OR "${CMAKE_CXX_COMPILER_ID}" STREQUAL "Clang")
+ set(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} -Wall -Wextra -Wno-unused-parameter")
+endif()
+
+find_package(precice REQUIRED CONFIG)
+
+add_executable(SolidSolver
+ src/SolidComputeSolution.cpp
+ src/SolidSolver.cpp)
+
+target_link_libraries(SolidSolver PRIVATE precice::precice)
diff --git a/elastic-tube-1d/solid-cpp/clean.sh b/elastic-tube-1d/solid-cpp/clean.sh
new file mode 100755
index 000000000..7330c8aaa
--- /dev/null
+++ b/elastic-tube-1d/solid-cpp/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_precice_logs .
diff --git a/elastic-tube-1d/solid-cpp/run.sh b/elastic-tube-1d/solid-cpp/run.sh
new file mode 100755
index 000000000..0c72002ce
--- /dev/null
+++ b/elastic-tube-1d/solid-cpp/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+./build/SolidSolver ../precice-config.xml
diff --git a/elastic-tube-1d/solid-cpp/src/SolidComputeSolution.cpp b/elastic-tube-1d/solid-cpp/src/SolidComputeSolution.cpp
new file mode 100644
index 000000000..45e3fdcb2
--- /dev/null
+++ b/elastic-tube-1d/solid-cpp/src/SolidComputeSolution.cpp
@@ -0,0 +1,17 @@
+#include
+#include "SolidSolver.h"
+
+void SolidComputeSolution(int chunkLength, double const * const pressure, double *crossSectionLength)
+{
+ /*
+ * Update displacement of membrane based on pressure data from the fluid solver
+ */
+ const double PI = 3.14159265359;
+ const double E = 10000;
+ const double c_mk2 = E / 2 * std::sqrt(PI);
+ const double pressure0 = 0.0;
+ for (int i = 0; i < chunkLength; i++) {
+ //crossSectionLength[i] = 4.0 / ((2.0 - pressure[i]) * (2.0 - pressure[i]));
+ crossSectionLength[i] = std::pow((pressure0 - 2.0 * c_mk2) / (pressure[i] - 2.0 * c_mk2), 2);
+ }
+}
diff --git a/elastic-tube-1d/solid-cpp/src/SolidSolver.cpp b/elastic-tube-1d/solid-cpp/src/SolidSolver.cpp
new file mode 100644
index 000000000..9080b850f
--- /dev/null
+++ b/elastic-tube-1d/solid-cpp/src/SolidSolver.cpp
@@ -0,0 +1,88 @@
+#include "SolidSolver.h"
+#include
+#include
+#include "precice/SolverInterface.hpp"
+
+int main(int argc, char **argv)
+{
+ std::cout << "Starting Solid Solver..." << std::endl;
+ using namespace precice;
+ using namespace precice::constants;
+
+ if (argc != 2) {
+ std::cout << "Fluid: Usage: " << argv[0] << " configurationFileName>" << std::endl;
+ std::cout << std::endl;
+
+ return -1;
+ }
+
+ std::string configFileName(argv[1]);
+ int domainSize = 100; // N
+ int chunkLength = domainSize + 1;
+
+ std::cout << "N: " << domainSize << std::endl;
+ std::cout << "inputs: " << argc << std::endl;
+
+ const std::string solverName = "Solid";
+
+ SolverInterface interface(solverName, configFileName, 0, 1);
+ std::cout << "preCICE configured..." << std::endl;
+
+ int dimensions = interface.getDimensions();
+ int meshID = interface.getMeshID("Solid-Nodes-Mesh");
+ int crossSectionLengthID = interface.getDataID("CrossSectionLength", meshID);
+ int pressureID = interface.getDataID("Pressure", meshID);
+
+ std::vector pressure(chunkLength, 0.0);
+ std::vector crossSectionLength(chunkLength, 1.0);
+ std::vector grid(dimensions * chunkLength);
+
+ for (int i = 0; i < chunkLength; i++) {
+ for (int j = 0; j < dimensions; j++) {
+ grid[i * dimensions + j] = i * (1 - j);
+ }
+ }
+
+ std::vector vertexIDs(chunkLength);
+ interface.setMeshVertices(meshID, chunkLength, grid.data(), vertexIDs.data());
+ std::cout << "Initialize preCICE..." << std::endl;
+ interface.initialize();
+
+ double t = 0;
+ double dt = 0.01;
+
+ if (interface.isActionRequired(actionWriteInitialData())) {
+ interface.writeBlockScalarData(crossSectionLengthID, chunkLength, vertexIDs.data(), crossSectionLength.data());
+ interface.markActionFulfilled(actionWriteInitialData());
+ }
+
+ interface.initializeData();
+
+ while (interface.isCouplingOngoing()) {
+ if (interface.isActionRequired(actionWriteIterationCheckpoint())) {
+ interface.markActionFulfilled(actionWriteIterationCheckpoint());
+ }
+
+ if (interface.isReadDataAvailable()) {
+ interface.readBlockScalarData(pressureID, chunkLength, vertexIDs.data(), pressure.data());
+ }
+
+ SolidComputeSolution(chunkLength, pressure.data(), crossSectionLength.data()); // Call Solver
+
+ if (interface.isWriteDataRequired(dt)) {
+ interface.writeBlockScalarData(crossSectionLengthID, chunkLength, vertexIDs.data(), crossSectionLength.data());
+ }
+
+ interface.advance(dt);
+
+ if (interface.isActionRequired(actionReadIterationCheckpoint())) { // i.e. fluid not yet converged
+ interface.markActionFulfilled(actionReadIterationCheckpoint());
+ } else {
+ t += dt;
+ }
+ }
+
+ std::cout << "Exiting SolidSolver" << std::endl;
+ interface.finalize();
+ return 0;
+}
diff --git a/elastic-tube-1d/solid-cpp/src/SolidSolver.h b/elastic-tube-1d/solid-cpp/src/SolidSolver.h
new file mode 100644
index 000000000..be7e3934a
--- /dev/null
+++ b/elastic-tube-1d/solid-cpp/src/SolidSolver.h
@@ -0,0 +1,5 @@
+#pragma once
+
+#include
+
+void SolidComputeSolution(int chunkLength, double const * const pressure, double *crossSectionLength);
diff --git a/elastic-tube-1d/solid-python/SolidSolver.py b/elastic-tube-1d/solid-python/SolidSolver.py
new file mode 100644
index 000000000..e31264ce8
--- /dev/null
+++ b/elastic-tube-1d/solid-python/SolidSolver.py
@@ -0,0 +1,106 @@
+from __future__ import division, print_function
+
+import os
+import sys
+import argparse
+import numpy as np
+import precice
+from precice import *
+
+
+r0 = 1 / np.sqrt(np.pi) # radius of the tube
+a0 = r0**2 * np.pi # cross sectional area
+tau = 10**10 # timestep size, set it to a large value to enforce tau from precice_config.xml
+N = 100 # number of elements in x direction
+p0 = 0 # pressure at outlet
+L = 10 # length of tube/simulation domain
+E = 10000 # elasticity module
+c_mk = np.sqrt(E / 2 / r0) # wave speed
+
+
+def crossSection0(N):
+ return a0 * np.ones(N + 1)
+
+###############
+
+
+print("Starting Solid Solver...")
+
+parser = argparse.ArgumentParser()
+parser.add_argument("configurationFileName", help="Name of the xml config file.", nargs='?', type=str,
+ default="precice-config.xml")
+
+try:
+ args = parser.parse_args()
+except SystemExit:
+ print("")
+ print("Did you forget adding the precice configuration file as an argument?")
+ print("Try '$ python SolidSolver.py precice-config.xml'")
+ quit()
+
+configFileName = args.configurationFileName
+
+print("N: " + str(N))
+
+solverName = "Solid"
+
+print("Configure preCICE...")
+interface = precice.Interface(solverName, configFileName, 0, 1)
+print("preCICE configured...")
+
+dimensions = interface.get_dimensions()
+
+pressure = p0 * np.ones(N + 1)
+crossSectionLength = a0 * np.ones(N + 1)
+
+meshID = interface.get_mesh_id("Solid-Nodes-Mesh")
+crossSectionLengthID = interface.get_data_id("CrossSectionLength", meshID)
+pressureID = interface.get_data_id("Pressure", meshID)
+
+vertexIDs = np.zeros(N + 1)
+grid = np.zeros([N + 1, dimensions])
+
+grid[:, 0] = np.linspace(0, L, N + 1) # x component
+grid[:, 1] = 0 # np.linspace(0, config.L, N+1) # y component, leave blank
+
+vertexIDs = interface.set_mesh_vertices(meshID, grid)
+
+t = 0
+
+print("Solid: init precice...")
+
+# preCICE defines timestep size of solver via precice-config.xml
+precice_dt = interface.initialize()
+
+if interface.is_action_required(action_write_initial_data()):
+ interface.write_block_scalar_data(crossSectionLengthID, vertexIDs, crossSectionLength)
+ interface.mark_action_fulfilled(action_write_initial_data())
+
+interface.initialize_data()
+
+if interface.is_read_data_available():
+ pressure = interface.read_block_scalar_data(pressureID, vertexIDs)
+
+crossSection0 = crossSection0(pressure.shape[0] - 1)
+pressure0 = p0 * np.ones_like(pressure)
+
+while interface.is_coupling_ongoing():
+ # When an implicit coupling scheme is used, checkpointing is required
+ if interface.is_action_required(action_write_iteration_checkpoint()):
+ interface.mark_action_fulfilled(action_write_iteration_checkpoint())
+
+ crossSectionLength = crossSection0 * (
+ (pressure0 - 2.0 * c_mk ** 2) ** 2 / (pressure - 2.0 * c_mk ** 2) ** 2)
+
+ interface.write_block_scalar_data(crossSectionLengthID, vertexIDs, crossSectionLength)
+ precice_dt = interface.advance(precice_dt)
+ pressure = interface.read_block_scalar_data(pressureID, vertexIDs)
+
+ if interface.is_action_required(action_read_iteration_checkpoint()): # i.e. not yet converged
+ interface.mark_action_fulfilled(action_read_iteration_checkpoint())
+ else:
+ t += precice_dt
+
+print("Exiting SolidSolver")
+
+interface.finalize()
diff --git a/elastic-tube-1d/solid-python/clean.sh b/elastic-tube-1d/solid-python/clean.sh
new file mode 100755
index 000000000..7330c8aaa
--- /dev/null
+++ b/elastic-tube-1d/solid-python/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_precice_logs .
diff --git a/elastic-tube-1d/solid-python/run.sh b/elastic-tube-1d/solid-python/run.sh
new file mode 100755
index 000000000..ad00c6c38
--- /dev/null
+++ b/elastic-tube-1d/solid-python/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+python3 ./SolidSolver.py ../precice-config.xml
diff --git a/elastic-tube-3d/README.md b/elastic-tube-3d/README.md
new file mode 100644
index 000000000..186c6d3ac
--- /dev/null
+++ b/elastic-tube-3d/README.md
@@ -0,0 +1,34 @@
+---
+title: Elastic tube 3D
+permalink: tutorials-elastic-tube-3d.html
+keywords: FSI, OpenFOAM, CalculiX, nearest-projection, IMVJ
+summary: Tutorial for an FSI simulation of a three-dimensional expanding tube scenario
+---
+
+## Setup
+
+The expanding tube test case involves a cylindrical fluid domain surrounded by a solid domain. A pressure inlet boundary condition is applied at the inlet for 3 milliseconds, and then 0 set to zero for a further 7 millisecond. The pressure of the fluid expands the tube which then relaxes once the pressure decreases.
+
+The expanding tube test case comes with the interface surface mesh connectivity of the solid domain. This allows the use of nearest-projection mapping of the displacements of the solid domain. In order to run the example with nearest projection mapping, the "node-mesh-with-connectivity" has been specified in the `solid-calculix/config.yml` file. More details can be found in the [CalculiX configuration description](adapter-calculix-config.html#nearest-projection-mapping).
+
+## Available solvers
+
+Fluid participant:
+
+* OpenFOAM. This tutorial is known to work with OpenFOAM 4.1, 5.0, but it should also work with newer versions. The case files are prepared for the latest versions of OpenFOAM and use the solver `pimpleFoam`. In case you are using a previous OpenFOAM version you need to adjust the solver to `pimpleDyMFoam` in the `Fluid/system/controlDict` file. For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+Solid participant:
+
+* CalculiX. This tutorial is known to work with CalculiX 2.15, but it should also work with newer versions. For more information, have a look at the [CalculiX adapter documentation](adapter-calculix-overview.html).
+
+## Running the simulation
+
+You can start the simulation by running the script `./run.sh` located in each participant directory. OpenFOAM can be executed in parallel by using an additional `run.sh -parallel` flag. The default setting uses 4 MPI ranks.
+
+## Post-processing
+
+You can visualize the results using paraView or `cgx`(for native CalculiX resul files), as usual. The total deformation is rather small. Multiplying the deformation by factor of 10 (warp by vector filter in paraView) and visualizing the fluid domain at `t=0.005s` looks as follows:
+
+
+
+{% include disclaimer.html content="This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks." %}
diff --git a/elastic-tube-3d/clean-tutorial.sh b/elastic-tube-3d/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/elastic-tube-3d/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/0.orig/U b/elastic-tube-3d/fluid-openfoam/0/U
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/0.orig/U
rename to elastic-tube-3d/fluid-openfoam/0/U
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/0.orig/p b/elastic-tube-3d/fluid-openfoam/0/p
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/0.orig/p
rename to elastic-tube-3d/fluid-openfoam/0/p
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/0.orig/pointDisplacement b/elastic-tube-3d/fluid-openfoam/0/pointDisplacement
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/0.orig/pointDisplacement
rename to elastic-tube-3d/fluid-openfoam/0/pointDisplacement
diff --git a/elastic-tube-3d/fluid-openfoam/clean.sh b/elastic-tube-3d/fluid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/elastic-tube-3d/fluid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/RASProperties b/elastic-tube-3d/fluid-openfoam/constant/RASProperties
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/RASProperties
rename to elastic-tube-3d/fluid-openfoam/constant/RASProperties
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/couplingProperties b/elastic-tube-3d/fluid-openfoam/constant/couplingProperties
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/couplingProperties
rename to elastic-tube-3d/fluid-openfoam/constant/couplingProperties
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/dynamicMeshDict b/elastic-tube-3d/fluid-openfoam/constant/dynamicMeshDict
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/dynamicMeshDict
rename to elastic-tube-3d/fluid-openfoam/constant/dynamicMeshDict
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/boundary b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/boundary
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/boundary
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/boundary
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/cellZones b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/cellZones
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/cellZones
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/cellZones
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/faceZones b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/faceZones
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/faceZones
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/faceZones
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/faces b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/faces
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/faces
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/faces
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/neighbour b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/neighbour
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/neighbour
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/neighbour
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/owner b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/owner
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/owner
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/owner
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/pointZones b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/pointZones
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/pointZones
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/pointZones
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/points b/elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/points
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/polyMesh/points
rename to elastic-tube-3d/fluid-openfoam/constant/polyMesh.orig/points
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/transportProperties b/elastic-tube-3d/fluid-openfoam/constant/transportProperties
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/transportProperties
rename to elastic-tube-3d/fluid-openfoam/constant/transportProperties
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/turbulenceProperties b/elastic-tube-3d/fluid-openfoam/constant/turbulenceProperties
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/constant/turbulenceProperties
rename to elastic-tube-3d/fluid-openfoam/constant/turbulenceProperties
diff --git a/elastic-tube-3d/fluid-openfoam/run.sh b/elastic-tube-3d/fluid-openfoam/run.sh
new file mode 100755
index 000000000..c305d6d9b
--- /dev/null
+++ b/elastic-tube-3d/fluid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+cp -r constant/polyMesh.orig constant/polyMesh
+touch fluid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/controlDict b/elastic-tube-3d/fluid-openfoam/system/controlDict
similarity index 95%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/controlDict
rename to elastic-tube-3d/fluid-openfoam/system/controlDict
index 62b6b599a..4247dc635 100755
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/controlDict
+++ b/elastic-tube-3d/fluid-openfoam/system/controlDict
@@ -40,7 +40,7 @@ timeFormat general;
timePrecision 8;
-runTimeModifiable yes;
+runTimeModifiable false;
adjustTimeStep no;
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/decomposeParDict b/elastic-tube-3d/fluid-openfoam/system/decomposeParDict
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/decomposeParDict
rename to elastic-tube-3d/fluid-openfoam/system/decomposeParDict
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/fvSchemes b/elastic-tube-3d/fluid-openfoam/system/fvSchemes
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/fvSchemes
rename to elastic-tube-3d/fluid-openfoam/system/fvSchemes
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/fvSolution b/elastic-tube-3d/fluid-openfoam/system/fvSolution
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/fvSolution
rename to elastic-tube-3d/fluid-openfoam/system/fvSolution
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/preciceDict b/elastic-tube-3d/fluid-openfoam/system/preciceDict
similarity index 89%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/preciceDict
rename to elastic-tube-3d/fluid-openfoam/system/preciceDict
index fcd534a79..152688f59 100644
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/system/preciceDict
+++ b/elastic-tube-3d/fluid-openfoam/system/preciceDict
@@ -7,7 +7,7 @@ FoamFile
object preciceDict;
}
-preciceConfig "precice-config.xml";
+preciceConfig "../precice-config.xml";
participant Fluid;
@@ -23,7 +23,7 @@ interfaces
readData
(
- DisplacementDeltas0
+ DisplacementDelta
);
writeData
@@ -43,7 +43,7 @@ interfaces
writeData
(
- Forces0
+ Force
);
};
};
@@ -51,4 +51,4 @@ interfaces
FSI
{
rho rho [1 -3 0 0 0 0 0] 1000;
-}
\ No newline at end of file
+}
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/time-series b/elastic-tube-3d/fluid-openfoam/time-series
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Fluid/time-series
rename to elastic-tube-3d/fluid-openfoam/time-series
diff --git a/elastic-tube-3d/images/tutorials-elastic-tube-3d-tube-result.png b/elastic-tube-3d/images/tutorials-elastic-tube-3d-tube-result.png
new file mode 100644
index 000000000..ff8fb2c5e
Binary files /dev/null and b/elastic-tube-3d/images/tutorials-elastic-tube-3d-tube-result.png differ
diff --git a/elastic-tube-3d/precice-config.xml b/elastic-tube-3d/precice-config.xml
new file mode 100644
index 000000000..b57775c4d
--- /dev/null
+++ b/elastic-tube-3d/precice-config.xml
@@ -0,0 +1,74 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/elastic-tube-3d/solid-calculix/all.msh b/elastic-tube-3d/solid-calculix/all.msh
new file mode 100644
index 000000000..991d11a47
--- /dev/null
+++ b/elastic-tube-3d/solid-calculix/all.msh
@@ -0,0 +1,12020 @@
+*node, nset=Nall
+1,0.005,-1.224647E-018,0
+2,0.005,-1.224647E-018,0.05
+3,0.006,-1.469576E-018,0
+4,0.006,-1.469576E-018,0.05
+5,0.004900117,0.0009944087,0.05
+6,0.004579226,0.002007658,0.05
+7,0.004048664,0.002933994,0.05
+8,0.003332322,0.003727684,0.05
+9,0.002525709,0.004315182,0.05
+10,0.001574829,0.004745515,0.05
+11,0.000493556,0.004975581,0.05
+12,-0.0005996313,0.004963914,0.05
+13,-0.001617083,0.004731284,0.05
+14,-0.002614797,0.004261788,0.05
+15,-0.003441352,0.003627271,0.05
+16,-0.004106671,0.002852236,0.05
+17,-0.004591285,0.001979925,0.05
+18,-0.004905328,0.0009683794,0.05
+19,-0.004998934,-0.0001032392,0.05
+20,-0.004863982,-0.00115831,0.05
+21,-0.004509195,-0.002160361,0.05
+22,-0.003990385,-0.003012777,0.05
+23,-0.003312634,-0.003745191,0.05
+24,-0.002480043,-0.004341588,0.05
+25,-0.00146821,-0.004779577,0.05
+26,-0.0004825337,-0.004976662,0.05
+27,0.0005179817,-0.004973097,0.05
+28,0.0016615,-0.004715869,0.05
+29,0.002665217,-0.00423044,0.05
+30,0.003452223,-0.003616926,0.05
+31,0.004101723,-0.002859347,0.05
+32,0.004605167,-0.001947419,0.05
+33,0.004900173,-0.0009941354,0.05
+34,0.005,-1.224647E-018,0.001178177
+35,0.005,-1.224647E-018,0.002218382
+36,0.005,-1.224647E-018,0.003291878
+37,0.005,-1.224647E-018,0.004560639
+38,0.005,-1.224647E-018,0.005557286
+39,0.005,-1.224647E-018,0.006659429
+40,0.005,-1.224647E-018,0.007766056
+41,0.005,-1.224647E-018,0.008939749
+42,0.005,-1.224647E-018,0.009982196
+43,0.005,-1.224647E-018,0.01105569
+44,0.005,-1.224647E-018,0.01232221
+45,0.005,-1.224647E-018,0.01331886
+46,0.005,-1.224647E-018,0.014421
+47,0.005,-1.224647E-018,0.01553211
+48,0.005,-1.224647E-018,0.01670132
+49,0.005,-1.224647E-018,0.01774601
+50,0.005,-1.224647E-018,0.01881951
+51,0.005,-1.224647E-018,0.02008378
+52,0.005,-1.224647E-018,0.02108043
+53,0.005,-1.224647E-018,0.02218257
+54,0.005,-1.224647E-018,0.02329817
+55,0.005,-1.224647E-018,0.02446289
+56,0.005,-1.224647E-018,0.02550982
+57,0.005,-1.224647E-018,0.02658332
+58,0.005,-1.224647E-018,0.02784536
+59,0.005,-1.224647E-018,0.028842
+60,0.005,-1.224647E-018,0.02994414
+61,0.005,-1.224647E-018,0.03106422
+62,0.005,-1.224647E-018,0.03222446
+63,0.005,-1.224647E-018,0.03327364
+64,0.005,-1.224647E-018,0.03434713
+65,0.005,-1.224647E-018,0.03560693
+66,0.005,-1.224647E-018,0.03660357
+67,0.005,-1.224647E-018,0.03770572
+68,0.005,-1.224647E-018,0.03883028
+69,0.005,-1.224647E-018,0.03998604
+70,0.005,-1.224647E-018,0.04103745
+71,0.005,-1.224647E-018,0.04225239
+72,0.005,-1.224647E-018,0.04324904
+73,0.005,-1.224647E-018,0.04435118
+74,0.005,-1.224647E-018,0.04555149
+75,0.005,-1.224647E-018,0.0466315
+76,0.005,-1.224647E-018,0.04772079
+77,0.005,-1.224647E-018,0.0487846
+78,0.004900117,0.0009944087,0
+79,0.004579226,0.002007658,0
+80,0.004048664,0.002933994,0
+81,0.003332322,0.003727684,0
+82,0.002525709,0.004315182,0
+83,0.001574829,0.004745515,0
+84,0.000493556,0.004975581,0
+85,-0.0005996313,0.004963914,0
+86,-0.001617083,0.004731284,0
+87,-0.002614797,0.004261788,0
+88,-0.003441352,0.003627271,0
+89,-0.004106671,0.002852236,0
+90,-0.004591285,0.001979925,0
+91,-0.004905328,0.0009683794,0
+92,-0.004998934,-0.0001032392,0
+93,-0.004863982,-0.00115831,0
+94,-0.004509195,-0.002160361,0
+95,-0.003990385,-0.003012777,0
+96,-0.003312634,-0.003745191,0
+97,-0.002480043,-0.004341588,0
+98,-0.00146821,-0.004779577,0
+99,-0.0004825337,-0.004976662,0
+100,0.0005179817,-0.004973097,0
+101,0.0016615,-0.004715869,0
+102,0.002665217,-0.00423044,0
+103,0.003452223,-0.003616926,0
+104,0.004101723,-0.002859347,0
+105,0.004605167,-0.001947419,0
+106,0.004900173,-0.0009941354,0
+107,0.005899708,0.001092448,0
+108,0.00562602,0.002085162,0
+109,0.005205043,0.002984547,0
+110,0.00464149,0.00380218,0
+111,0.003950797,0.004515662,0
+112,0.003104717,0.00513427,0
+113,0.002176041,0.005591498,0
+114,0.001223988,0.005873828,0
+115,0.0001340536,0.005998502,0
+116,-0.0008571627,0.005938457,0
+117,-0.001824899,0.005715745,0
+118,-0.002786254,0.00531383,0
+119,-0.003658124,0.004755852,0
+120,-0.004392443,0.004087352,0
+121,-0.005046811,0.003244949,0
+122,-0.005520151,0.002351156,0
+123,-0.005832341,0.001408473,0
+124,-0.005986239,0.0004061345,0
+125,-0.005960124,-0.0006905962,0
+126,-0.005764588,-0.001664188,0
+127,-0.005411149,-0.002592194,0
+128,-0.004905953,-0.003454218,0
+129,-0.004216923,-0.004268203,0
+130,-0.003455179,-0.004905276,0
+131,-0.002574269,-0.005419699,0
+132,-0.001635795,-0.00577271,0
+133,-0.0006612525,-0.005963451,0
+134,0.000331403,-0.005990841,0
+135,0.001314981,-0.005854129,0
+136,0.002262538,-0.00555706,0
+137,0.003157107,-0.005102223,0
+138,0.003978455,-0.004491314,0
+139,0.004664753,-0.003773602,0
+140,0.005250252,-0.002904282,0
+141,0.00565737,-0.001998539,0
+142,0.005917824,-0.0009896273,0
+143,0.005899094,0.001095761,0.05
+144,0.005624894,0.002088198,0.05
+145,0.005203497,0.002987243,0.05
+146,0.004639603,0.003804482,0.05
+147,0.003948654,0.004517536,0.05
+148,0.003102393,0.005135675,0.05
+149,0.002173632,0.005592435,0.05
+150,0.001221585,0.005874328,0.05
+151,0.0001317308,0.005998554,0.05
+152,-0.0008593326,0.005938143,0.05
+153,-0.001826863,0.005715118,0.05
+154,-0.002787964,0.005312933,0.05
+155,-0.003659551,0.004754754,0.05
+156,-0.00439358,0.00408613,0.05
+157,-0.005047643,0.003243655,0.05
+158,-0.005520702,0.002349861,0.05
+159,-0.005832641,0.001407231,0.05
+160,-0.005986316,0.0004049908,0.05
+161,-0.005960007,-0.0006916049,0.05
+162,-0.005764343,-0.001665038,0.05
+163,-0.005410823,-0.002592874,0.05
+164,-0.004905594,-0.003454728,0.05
+165,-0.004216573,-0.00426855,0.05
+166,-0.003454884,-0.004905485,0.05
+167,-0.00257402,-0.005419817,0.05
+168,-0.001635699,-0.005772737,0.05
+169,-0.000661283,-0.005963447,0.05
+170,0.0003312417,-0.00599085,0.05
+171,0.001314695,-0.005854193,0.05
+172,0.002262146,-0.00555722,0.05
+173,0.003156636,-0.005102514,0.05
+174,0.003977942,-0.004491767,0.05
+175,0.004664241,-0.003774236,0.05
+176,0.005249794,-0.00290511,0.05
+177,0.005657012,-0.001999555,0.05
+178,0.005917624,-0.0009908184,0.05
+179,0.006,-1.469576E-018,0.001178177
+180,0.006,-1.469576E-018,0.002218382
+181,0.006,-1.469576E-018,0.003291878
+182,0.006,-1.469576E-018,0.004560639
+183,0.006,-1.469576E-018,0.005557286
+184,0.006,-1.469576E-018,0.006659429
+185,0.006,-1.469576E-018,0.007766056
+186,0.006,-1.469576E-018,0.008939749
+187,0.006,-1.469576E-018,0.009982196
+188,0.006,-1.469576E-018,0.01105569
+189,0.006,-1.469576E-018,0.01232221
+190,0.006,-1.469576E-018,0.01331886
+191,0.006,-1.469576E-018,0.014421
+192,0.006,-1.469576E-018,0.01553211
+193,0.006,-1.469576E-018,0.01670132
+194,0.006,-1.469576E-018,0.01774601
+195,0.006,-1.469576E-018,0.01881951
+196,0.006,-1.469576E-018,0.02008378
+197,0.006,-1.469576E-018,0.02108043
+198,0.006,-1.469576E-018,0.02218257
+199,0.006,-1.469576E-018,0.02329817
+200,0.006,-1.469576E-018,0.02446289
+201,0.006,-1.469576E-018,0.02550982
+202,0.006,-1.469576E-018,0.02658332
+203,0.006,-1.469576E-018,0.02784536
+204,0.006,-1.469576E-018,0.028842
+205,0.006,-1.469576E-018,0.02994414
+206,0.006,-1.469576E-018,0.03106422
+207,0.006,-1.469576E-018,0.03222446
+208,0.006,-1.469576E-018,0.03327364
+209,0.006,-1.469576E-018,0.03434713
+210,0.006,-1.469576E-018,0.03560693
+211,0.006,-1.469576E-018,0.03660357
+212,0.006,-1.469576E-018,0.03770572
+213,0.006,-1.469576E-018,0.03883028
+214,0.006,-1.469576E-018,0.03998604
+215,0.006,-1.469576E-018,0.04103745
+216,0.006,-1.469576E-018,0.04225239
+217,0.006,-1.469576E-018,0.04324904
+218,0.006,-1.469576E-018,0.04435118
+219,0.006,-1.469576E-018,0.04555149
+220,0.006,-1.469576E-018,0.0466315
+221,0.006,-1.469576E-018,0.04772079
+222,0.006,-1.469576E-018,0.0487846
+223,0.004810903,0.001362062,0.04899511
+224,0.003781359,0.003271288,0.04891045
+225,0.002073388,0.004549842,0.04901007
+226,-0.00002343718,0.004999945,0.04888356
+227,-0.002150295,0.004514004,0.04883044
+228,-0.003794587,0.003255934,0.04898866
+229,-0.004786769,0.001444589,0.0490252
+230,-0.004959964,-0.0006314722,0.04888243
+231,-0.004279874,-0.002585087,0.04899151
+232,-0.002869832,-0.004094395,0.04904035
+233,-0.00095714,-0.004907533,0.04888392
+234,0.00113413,-0.004869676,0.04905568
+235,0.003064736,-0.003950619,0.04899582
+236,0.004423052,-0.002331655,0.04903957
+237,0.004949522,-0.0007086865,0.001235364
+238,0.004913527,-0.0009258812,0.002521021
+239,0.004914754,-0.0009193464,0.003741453
+240,0.004902186,-0.000984163,0.004935464
+241,0.004889289,-0.001046354,0.006040872
+242,0.004884461,-0.001068662,0.007178807
+243,0.004881778,-0.001080853,0.008317887
+244,0.004883306,-0.001073928,0.00942323
+245,0.004902467,-0.000982759,0.0105087
+246,0.004902258,-0.0009838027,0.01166875
+247,0.004873994,-0.00111543,0.01275837
+248,0.004872352,-0.001122579,0.01384255
+249,0.004880579,-0.001086254,0.01496594
+250,0.00488729,-0.00105565,0.01610813
+251,0.004881452,-0.001082327,0.01724307
+252,0.004872772,-0.001120756,0.01836825
+253,0.004865425,-0.001152231,0.0194934
+254,0.004862432,-0.0011648,0.02059902
+255,0.004884771,-0.001067245,0.02166627
+256,0.00489395,-0.001024329,0.02278513
+257,0.004898239,-0.001003619,0.02385634
+258,0.004896961,-0.001009839,0.02498138
+259,0.004883784,-0.001071754,0.02608035
+260,0.00488115,-0.001083684,0.02721236
+261,0.004880697,-0.001085726,0.02831655
+262,0.004901813,-0.000986019,0.02939046
+263,0.004901813,-0.0009860158,0.03052935
+264,0.004881963,-0.001080019,0.03162193
+265,0.00487531,-0.001109662,0.03271825
+266,0.004890234,-0.001041926,0.03380791
+267,0.004889226,-0.001046646,0.03496386
+268,0.004862196,-0.001165784,0.03606263
+269,0.00485621,-0.001190473,0.03717111
+270,0.004861201,-0.001169926,0.03829571
+271,0.00487613,-0.001106055,0.03941459
+272,0.004898076,-0.001004417,0.04051261
+273,0.004900933,-0.0009903822,0.04167101
+274,0.004875505,-0.001108805,0.0427703
+275,0.004871564,-0.001125994,0.0438759
+276,0.004884018,-0.001070684,0.04500806
+277,0.004898484,-0.001002427,0.0461384
+278,0.004918303,-0.0009001663,0.04721766
+279,0.004941879,-0.0007601548,0.04822216
+280,0.00483094,0.001289192,0.0009186399
+281,0.004425063,0.002327835,0.0009390588
+282,0.00382216,0.003223521,0.0009650209
+283,0.003054815,0.003958295,0.0009414495
+284,0.002133163,0.004522125,0.0009076604
+285,0.001092242,0.004879242,0.0009268479
+286,0.00003883677,0.004999849,0.001012954
+287,-0.001018669,0.004895132,0.001079531
+288,-0.00202401,0.004572022,0.0009890285
+289,-0.002924812,0.004055302,0.001000207
+290,-0.003699225,0.003363887,0.001069402
+291,-0.004309621,0.002535186,0.0009696127
+292,-0.004742738,0.001583172,0.0009877122
+293,-0.004969004,0.0005558772,0.001073335
+294,-0.004973899,-0.0005102215,0.001087807
+295,-0.004750847,-0.00155867,0.001075744
+296,-0.004313556,-0.002528485,0.001036763
+297,-0.003729282,-0.003330534,0.0009438801
+298,-0.002948629,-0.004038018,0.0009394313
+299,-0.002059146,-0.004556305,0.001034304
+300,-0.001026309,-0.004893535,0.001122927
+301,0.00003153563,-0.004999901,0.001125056
+302,0.001093774,-0.004878899,0.001096832
+303,0.002086015,-0.004544067,0.0009318886
+304,0.00300717,-0.003994613,0.0008724352
+305,0.003754318,-0.003302286,0.0009561463
+306,0.004301589,-0.00254879,0.0009589398
+307,0.004944441,0.0007433028,0.001772513
+308,0.004900441,0.0009928127,0.003854567
+309,0.004882203,0.001078931,0.006131748
+310,0.00489644,0.00101236,0.008371263
+311,0.00490143,0.000987917,0.01057694
+312,0.004888218,0.001051347,0.01277908
+313,0.004870736,0.001129571,0.01504215
+314,0.004900874,0.0009906723,0.01730906
+315,0.004850633,0.001212997,0.01943703
+316,0.004885153,0.001065493,0.02159842
+317,0.004869424,0.001135212,0.02395948
+318,0.004923907,0.0008689905,0.026105
+319,0.004920733,0.0008867871,0.02830837
+320,0.004861165,0.001170075,0.03047413
+321,0.004894514,0.00102163,0.03279027
+322,0.004841251,0.001249915,0.03494655
+323,0.004869503,0.001134874,0.03715812
+324,0.004866132,0.001149245,0.03956296
+325,0.004880668,0.001085854,0.04168585
+326,0.00487384,0.001116102,0.0438349
+327,0.004934155,0.0008087743,0.04611287
+328,0.004936193,0.0007962382,0.04813129
+329,0.004817855,-0.001337264,0.04909186
+330,0.004385988,0.002400647,0.04893972
+331,0.002990732,0.004006934,0.04899827
+332,0.001060996,0.004886132,0.04893391
+333,-0.001100873,0.004877303,0.04884133
+334,-0.003074811,0.003942783,0.04887606
+335,-0.004382313,0.00240735,0.04908117
+336,-0.004978559,0.0004625499,0.04890509
+337,-0.004718537,-0.001653906,0.04893656
+338,-0.003652988,-0.003414042,0.0490561
+339,-0.001961292,-0.004599275,0.04891411
+340,0.0000825357,-0.004999319,0.04891994
+341,0.00216444,-0.004507238,0.04907456
+342,0.003824516,-0.003220726,0.04898826
+343,0.004690598,-0.001731557,0.001469353
+344,0.004892245,0.001032441,0.004996549
+345,0.004924365,0.0008663909,0.002747298
+346,0.004882363,0.001078209,0.007277467
+347,0.004911061,0.0009388731,0.009475752
+348,0.004876363,0.001105026,0.01167448
+349,0.004885329,0.00106469,0.01391204
+350,0.004877884,0.001098295,0.01619096
+351,0.004931827,0.0008228521,0.0183329
+352,0.004915752,0.000913994,0.02054857
+353,0.004877105,0.001101748,0.02277682
+354,0.004886397,0.001059777,0.0250805
+355,0.004847294,0.00122627,0.02721304
+356,0.004882988,0.001075375,0.02933542
+357,0.004867445,0.00114367,0.03164561
+358,0.004927201,0.0008501124,0.03383539
+359,0.004909735,0.0009457835,0.03608159
+360,0.004861226,0.00116982,0.03836745
+361,0.004917608,0.0009039521,0.04060524
+362,0.004917532,0.0009043647,0.0427568
+363,0.004886444,0.001059558,0.04505546
+364,0.004916619,0.0009093186,0.04712224
+365,0.004724046,0.001638105,0.001959359
+366,0.001670858,0.004712561,0.04780489
+367,0.004178476,0.002745968,0.04760694
+368,-0.000538863,0.004970878,0.04763524
+369,-0.002729412,0.004189309,0.04743955
+370,0.004443429,0.002292583,0.01445893
+371,-0.004159174,0.002775117,0.0480839
+372,-0.004874121,0.001114876,0.04770315
+373,-0.004866459,-0.001147857,0.04765543
+374,-0.003930919,-0.003089964,0.04794152
+375,-0.00247912,-0.004342115,0.04775891
+376,-0.001474137,-0.004777753,0.04762294
+377,0.0007428965,-0.004944502,0.04784269
+378,0.002602915,-0.004269055,0.04793681
+379,0.004194875,-0.00272085,0.04793378
+380,0.004482573,0.002215071,0.006796312
+381,0.004499996,0.002179458,0.0169614
+382,0.002567566,0.004290409,0.04804435
+383,0.0006065803,0.00496307,0.0477323
+384,0.004617398,0.001918237,0.009029569
+385,0.00458957,-0.001983897,0.002992445
+386,0.004627932,-0.001892681,0.004205645
+387,0.004495959,-0.002187774,0.005304327
+388,0.004494888,-0.002189973,0.006492768
+389,0.004469296,-0.00224174,0.007716798
+390,0.00443018,-0.002318082,0.008879351
+391,0.004482888,-0.002214433,0.01001173
+392,0.00460965,-0.001936784,0.0110579
+393,0.004455828,-0.00226839,0.01207995
+394,0.004365345,-0.002437983,0.01320238
+395,0.004433692,-0.002311358,0.01434469
+396,0.004481696,-0.002216845,0.01553953
+397,0.004485094,-0.002209962,0.01667221
+398,0.004452106,-0.002275687,0.01785093
+399,0.00437122,-0.002427434,0.01899152
+400,0.004338934,-0.002484683,0.02015952
+401,0.004374488,-0.00242154,0.02130983
+402,0.004540945,-0.002092802,0.02230881
+403,0.004450673,-0.002278488,0.02336968
+404,0.004571564,-0.002025045,0.02440315
+405,0.00448792,-0.002204217,0.02545445
+406,0.00445568,-0.002268681,0.0266458
+407,0.004417746,-0.002341692,0.02781064
+408,0.004472961,-0.002234418,0.02893368
+409,0.00460785,-0.001941062,0.02995941
+410,0.004471424,-0.002237492,0.03098914
+411,0.004410124,-0.002356014,0.0321193
+412,0.004429652,-0.00231909,0.03328627
+413,0.004551547,-0.002069643,0.03435265
+414,0.004392076,-0.002389491,0.03538697
+415,0.004334501,-0.002492409,0.03655056
+416,0.004337123,-0.002487844,0.03775447
+417,0.004373459,-0.002423398,0.03894987
+418,0.004457761,-0.00226459,0.04008021
+419,0.004601051,-0.001957123,0.0411124
+420,0.004461196,-0.002257815,0.04217105
+421,0.004390409,-0.002392553,0.04333676
+422,0.004424608,-0.0023287,0.04454089
+423,0.004510092,-0.002158488,0.04573769
+424,0.004590942,-0.00198072,0.0469421
+425,0.004686265,-0.001743249,0.0480708
+426,0.004258428,0.002620265,0.002059631
+427,0.00356721,0.003503572,0.002097387
+428,0.002723833,0.004192939,0.001961752
+429,0.001700895,0.004701803,0.001897116
+430,0.0006196541,0.004961454,0.002064173
+431,-0.0004242089,0.004981972,0.002280365
+432,-0.001473415,0.004777975,0.00227924
+433,-0.002405737,0.004383199,0.001998018
+434,-0.003226563,0.003819593,0.002250558
+435,-0.003986126,0.00301841,0.00223661
+436,-0.004514389,0.002149486,0.00197267
+437,-0.00484463,0.001236753,0.002226222
+438,-0.004997543,0.0001567235,0.002257815
+439,-0.004904738,-0.0009713635,0.00224986
+440,-0.004570193,-0.002028136,0.002226095
+441,-0.004045805,-0.002937935,0.002195945
+442,-0.003405171,-0.003661258,0.001924157
+443,-0.002632523,-0.004250861,0.002115109
+444,-0.001610646,-0.004733479,0.002246302
+445,-0.0005147307,-0.004973435,0.002396971
+446,0.0006191572,-0.004961516,0.002389788
+447,0.001712202,-0.004697698,0.002271966
+448,0.002566878,-0.00429082,0.001845748
+449,0.00334765,-0.003713925,0.001894567
+450,0.004051253,-0.002930417,0.0023274
+451,0.004462817,0.002254609,0.008030191
+452,0.004543581,0.002087073,0.00428434
+453,0.004489829,0.002200326,0.005500859
+454,0.004687416,0.001740152,0.04784662
+455,0.004441377,0.002296555,0.01102052
+456,0.004649228,0.001839748,0.003096402
+457,0.004543118,0.00208808,0.01332471
+458,0.004621789,0.001907633,0.009970946
+459,0.004445054,0.00228943,0.01571663
+460,0.004416989,0.00234312,0.01223746
+461,0.004635623,0.001873766,0.01826082
+462,0.00451456,0.002149128,0.02062237
+463,0.004501271,0.002176823,0.02211934
+464,0.004404475,0.002366559,0.02474488
+465,0.004581647,0.002002127,0.02606299
+466,0.004568706,0.002031483,0.02838772
+467,0.004426885,0.002324368,0.02969898
+468,0.004465887,0.002248522,0.03235887
+469,0.004612771,0.001929338,0.03371136
+470,0.004487053,0.002205982,0.03616778
+471,0.004450568,0.002278694,0.03777346
+472,0.00450166,0.002176018,0.04081471
+473,0.004506965,0.00216501,0.04275186
+474,0.004475252,0.002229825,0.04458503
+475,0.004609833,0.001936347,0.04632317
+476,-0.003598477,0.00347145,0.04764289
+477,-0.001667937,0.004713596,0.04745266
+478,0.003394277,0.00367136,0.04775224
+479,-0.00459278,0.001976454,0.04810768
+480,-0.005,0.0000005045293,0.04758111
+481,-0.004507381,-0.002164144,0.04785019
+482,-0.003268129,-0.00378409,0.04809578
+483,-0.0003276021,-0.004989256,0.04762814
+484,0.001688043,-0.004706433,0.04814902
+485,0.003471675,-0.003598259,0.04789036
+486,0.004177515,0.00274743,0.03479511
+487,0.004148995,0.002790312,0.02725148
+488,0.004198824,0.002714752,0.01935977
+489,0.004443385,0.002292669,0.02348799
+490,0.004391428,0.002390682,0.03105669
+491,0.004401567,0.002371962,0.03923877
+492,0.003874706,0.003160166,0.01791246
+493,0.0006349864,-0.004959515,0.04628959
+494,-0.003299916,-0.003756402,0.04670205
+495,0.003911401,-0.003114634,0.004052415
+496,-0.004418977,0.002339368,0.04675431
+497,0.003745628,0.00331214,0.04595562
+498,0.003353286,0.003708837,0.01146519
+499,0.003707937,-0.003354281,0.005703076
+500,0.003816715,-0.003229967,0.006997792
+501,0.003551817,-0.003519175,0.008250541
+502,0.003563497,-0.003507348,0.009653299
+503,0.003881867,-0.003151366,0.01099266
+504,0.003451675,-0.003617449,0.01227166
+505,0.003260305,-0.003790833,0.01372137
+506,0.003760126,-0.003295671,0.01494909
+507,0.003649355,-0.003417925,0.01610461
+508,0.003772215,-0.003281827,0.01724803
+509,0.00346407,-0.003605582,0.01835292
+510,0.003341968,-0.003719039,0.01969457
+511,0.003341202,-0.003719727,0.02114061
+512,0.003559595,-0.003511308,0.02268811
+513,0.00366134,-0.003405083,0.02440571
+514,0.003792864,-0.003257941,0.02589296
+515,0.003529003,-0.003542053,0.0272131
+516,0.003516345,-0.003554619,0.02863807
+517,0.003875021,-0.003159781,0.02995358
+518,0.003516644,-0.003554323,0.0312658
+519,0.003536245,-0.003534822,0.03271244
+520,0.003640127,-0.003427751,0.03423702
+521,0.003339813,-0.003720975,0.03567105
+522,0.003325911,-0.003733406,0.03706806
+523,0.003394614,-0.003671048,0.03848976
+524,0.003478356,-0.003591801,0.03989164
+525,0.003863171,-0.003174258,0.04117614
+526,0.003491606,-0.003578923,0.04254123
+527,0.003454987,-0.003614286,0.04401459
+528,0.003689699,-0.003374332,0.04540966
+529,0.003965319,-0.003045692,0.04671178
+530,0.003554036,0.003516934,0.01325835
+531,0.003180413,0.003858105,0.003373833
+532,0.002283943,0.004447877,0.002965262
+533,0.001305536,0.004826549,0.003043402
+534,0.0003430182,0.00498822,0.003618717
+535,-0.0009343112,0.004911931,0.003842737
+536,-0.00229526,0.004442047,0.003503339
+537,-0.003556557,0.003514385,0.003586544
+538,-0.004450534,0.00227876,0.003472221
+539,-0.004898116,0.001004223,0.003644344
+540,-0.0049916,-0.000289703,0.003556761
+541,-0.004752296,-0.001554246,0.003595412
+542,-0.004223092,-0.002676844,0.003693347
+543,-0.003418916,-0.003648426,0.00340567
+544,-0.002373565,-0.004400703,0.003322689
+545,-0.001277616,-0.004834015,0.003853253
+546,0.00009992658,-0.004999001,0.004078933
+547,0.001502794,-0.004768816,0.003799484
+548,0.002905288,-0.004069313,0.003189406
+549,-0.004907982,0.0009548345,0.04607884
+550,0.003603024,0.00346673,0.02865214
+551,0.003658004,0.003408666,0.0370988
+552,0.003126451,0.003901962,0.02420114
+553,0.003568436,0.003502323,0.02582545
+554,0.003526195,0.003544848,0.04199283
+555,0.003792336,0.003258556,0.02151003
+556,0.003489324,0.003581148,0.03185639
+557,0.003781032,0.003271666,0.03328985
+558,0.003580087,0.003490413,0.0438102
+559,0.003268912,0.003783413,0.03027051
+560,0.003457912,0.003611488,0.04019779
+561,0.003410007,0.003656754,0.0385585
+562,-0.004104734,-0.002855023,0.04680988
+563,0.002606558,0.004266832,0.04672446
+564,0.003697389,0.003365905,0.02277415
+565,-0.004652278,-0.001832024,0.04632888
+566,0.003664845,0.00340131,0.01654916
+567,0.003446037,0.003622821,0.01499497
+568,0.001805382,-0.004662681,0.04689679
+569,0.004068251,0.002906774,0.00335829
+570,-0.0009745261,0.00490411,0.0459459
+571,-0.002149619,-0.004514326,0.0461754
+572,-0.0007558889,-0.004942533,0.04603091
+573,0.0001609088,0.00499741,0.04646684
+574,0.003604619,0.003465072,0.004833782
+575,0.001421497,0.004793678,0.04635794
+576,0.003329088,0.003730572,0.03582229
+577,-0.004972188,-0.0005266384,0.04604653
+578,0.003494063,0.003576524,0.00774277
+579,0.003338239,0.003722387,0.02041962
+580,-0.00355511,0.003515849,0.04598139
+581,-0.004998135,0.000136558,0.04415195
+582,0.003763069,0.003292311,0.009530102
+583,-0.002976551,-0.00401748,0.04452954
+584,0.002953531,-0.004034434,0.04660052
+585,0.001943295,0.004606908,0.04308677
+586,0.001779493,0.004672623,0.01428277
+587,0.002082077,-0.004545872,0.008927346
+588,0.001754667,-0.004682002,0.01260193
+589,0.001406938,-0.004797971,0.01414428
+590,0.001603811,-0.004735799,0.02230989
+591,0.0021137,-0.004531255,0.02984536
+592,0.002277412,-0.004451224,0.03329764
+593,0.001384783,-0.004804412,0.03633183
+594,0.001894102,-0.004627351,0.03785925
+595,0.001889532,-0.004629219,0.04322344
+596,0.002109376,-0.00453327,0.0451933
+597,0.001867807,0.004638027,0.041137
+598,-0.002339103,0.004419117,0.04578921
+599,0.003708308,0.003353871,0.006220323
+600,0.001604857,0.004735444,0.02564287
+601,0.002550732,-0.004300438,0.004974312
+602,0.002863694,0.00409869,0.03436206
+603,0.002399405,0.004386668,0.04503806
+604,0.002443731,0.00436213,0.02736482
+605,0.002234301,0.004473019,0.03284533
+606,0.002941968,0.004042873,0.01908238
+607,-0.003191144,0.003849233,0.0439889
+608,0.001572792,0.004746191,0.01244784
+609,0.00245558,-0.004355471,0.006898868
+610,-0.001407054,0.004797937,0.04400164
+611,-0.004722795,-0.001641709,0.04440103
+612,-0.00141123,-0.00479671,0.04416697
+613,0.001982045,0.00459037,0.004587756
+614,0.00121422,0.004850327,0.02927073
+615,0.0004020736,-0.004983807,0.04437211
+616,0.0004508685,0.00497963,0.04456017
+617,0.001738071,0.004688188,0.01048345
+618,0.00187168,0.004636466,0.03727859
+619,0.002535122,0.004309658,0.01754604
+620,0.002178991,-0.004500222,0.01076285
+621,0.002447791,-0.004359853,0.01533527
+622,0.002262054,-0.004459048,0.01703947
+623,0.001855669,-0.004642897,0.01876729
+624,0.001693182,-0.004704587,0.02050568
+625,0.001512503,-0.004765746,0.02426996
+626,0.002414287,-0.004378495,0.02593774
+627,0.001959,-0.004600252,0.02785979
+628,0.001904253,-0.004623183,0.0316972
+629,0.001676843,-0.004710435,0.03468486
+630,0.001820901,-0.004656642,0.03942835
+631,0.002121133,-0.00452778,0.04130218
+632,0.0003529718,0.004987526,0.00538292
+633,-0.001446008,0.004786341,0.005724978
+634,-0.002815159,0.004132176,0.005010911
+635,-0.003932843,0.003087514,0.005254239
+636,-0.004675664,0.001771487,0.005355687
+637,-0.00498547,0.000380906,0.005310735
+638,-0.00491496,-0.0009182436,0.004983939
+639,-0.004520876,-0.002135809,0.005478065
+640,-0.003701511,-0.003361371,0.005466244
+641,-0.002509169,-0.00432482,0.004948906
+642,-0.001102142,-0.004877016,0.00567065
+643,0.0007865385,-0.004937748,0.005855908
+644,0.002203254,0.004488393,0.0064015
+645,0.0005866139,0.004965469,0.023757
+646,0.001937581,0.004609314,0.008522369
+647,0.002177195,0.004501091,0.02220142
+648,0.001543404,0.004755829,0.03125591
+649,-0.004029859,-0.00295977,0.04516524
+650,0.001827928,0.004653889,0.03917804
+651,-0.004487468,0.002205138,0.04441819
+652,0.002034669,0.004567288,0.0160161
+653,-0.003962241,-0.003049696,0.04317275
+654,-0.0007668944,0.004940837,0.01168598
+655,0.0002121121,0.004995499,0.007289676
+656,-0.0001460935,0.004997865,0.009410347
+657,0.00002760196,0.004999924,0.02739992
+658,0.001761476,0.004679445,0.03561837
+659,-0.0007600352,0.004941897,0.02174414
+660,0.001450591,0.004784954,0.02049071
+661,-0.0006036205,0.00496343,0.02548831
+662,-0.004137931,0.002806693,0.04214718
+663,0.0008269504,-0.004931141,0.007812952
+664,-0.000170618,-0.004997088,0.0422866
+665,-0.00001796533,0.004999968,0.01572401
+666,-0.0002269114,0.004994848,0.04213875
+667,0.0002237273,0.004994992,0.04006964
+668,-0.0009126508,0.004916001,0.03113426
+669,-0.002467899,-0.004348503,0.0424103
+670,-0.0003038463,0.004990759,0.01378777
+671,-0.0008137025,-0.004933345,0.03514558
+672,-0.0001239885,-0.004998462,0.009628506
+673,-0.0001838323,-0.004996619,0.0286218
+674,0.0002759107,-0.004992382,0.03304174
+675,-0.001731899,0.004690472,0.0291043
+676,-0.004804429,-0.001384723,0.04231587
+677,0.001147478,0.004866548,0.03422931
+678,-0.002763434,-0.004166945,0.00693552
+679,-0.00104807,-0.004888921,0.007675017
+680,0.0003871706,-0.004984987,0.02649232
+681,-0.001715952,0.004696329,0.008013368
+682,-0.002044218,0.004563022,0.02399381
+683,-0.0003864193,-0.004985046,0.02133571
+684,-0.0001293697,0.004998326,0.03302654
+685,-0.0002702254,0.004992692,0.0380297
+686,0.0002895749,-0.004991608,0.04030727
+687,0.001386618,0.004803883,0.01880673
+688,0.000223804,-0.004994989,0.01153496
+689,-0.0005219881,-0.004972678,0.01342901
+690,-0.0002016618,-0.004995932,0.0308294
+691,0.0002982206,-0.004991099,0.01569176
+692,0.0002537928,-0.004993555,0.01761383
+693,-0.000004642497,-0.004999998,0.01952468
+694,-0.0006600747,-0.004956239,0.02322198
+695,-0.0008804523,-0.00492187,0.02510156
+696,-0.000471957,-0.004977676,0.03805499
+697,-0.003886901,-0.003145156,0.04068685
+698,-0.000472433,0.004977631,0.03569154
+699,-0.002336643,-0.004420419,0.02960646
+700,-0.001893558,-0.004627574,0.0114699
+701,-0.002237728,-0.004471306,0.02692344
+702,-0.002692072,-0.004213401,0.02211539
+703,-0.002724321,0.004192622,0.03713455
+704,-0.001725699,0.004692757,0.03984434
+705,-0.002995314,0.00400351,0.006693386
+706,-0.004253871,0.002627656,0.007034731
+707,-0.004913375,0.0009266877,0.007013782
+708,-0.004923425,-0.0008717139,0.006702797
+709,-0.004270962,-0.002599785,0.007666904
+710,-0.002892627,-0.004078322,0.009342562
+711,-0.002178715,0.004500355,0.01558457
+712,-0.002263993,0.004458064,0.01355308
+713,-0.002936878,-0.004046572,0.03445262
+714,0.0005508695,0.004969562,0.01744227
+715,-0.002741972,0.004181099,0.02672612
+716,-0.004937642,0.0007872056,0.04217893
+717,-0.002466331,0.004349392,0.04198639
+718,-0.004736402,0.001602029,0.04010523
+719,-0.004934338,-0.0008076578,0.04013137
+720,-0.002326053,0.004426,0.01010452
+721,-0.002675295,0.004224073,0.03373644
+722,-0.000403164,0.004983719,0.01936893
+723,-0.001743304,-0.004686245,0.04042964
+724,-0.002844023,-0.004112363,0.02435802
+725,-0.00301794,0.003986482,0.031166
+726,-0.002957179,-0.004031761,0.01352573
+727,-0.003292232,0.003763138,0.01218611
+728,-0.00262161,0.0042576,0.01978086
+729,-0.002869416,-0.004094686,0.03877765
+730,-0.003539736,0.003531327,0.03992884
+731,-0.001544212,0.004755566,0.01760252
+732,-0.002790101,-0.004149137,0.0366367
+733,-0.003436782,0.003631601,0.02208956
+734,-0.004620043,-0.001911858,0.01001567
+735,-0.004420723,-0.002336066,0.03800513
+736,-0.004582536,0.002000092,0.0354812
+737,-0.004137961,0.002806649,0.02455815
+738,-0.004605799,0.001945923,0.03219525
+739,-0.004067967,0.002907172,0.01477794
+740,-0.002178036,-0.004500684,0.0323255
+741,-0.001826457,-0.004654466,0.01499082
+742,-0.004574531,-0.002018332,0.02287536
+743,-0.002142752,-0.004517589,0.02014163
+744,-0.004284574,-0.00257729,0.02565088
+745,-0.003894078,-0.003136264,0.01176678
+746,-0.003461753,0.003607806,0.008595087
+747,-0.004678334,0.001764423,0.008780888
+748,-0.004984833,-0.0003891481,0.008576008
+749,-0.001768477,-0.004676803,0.01680385
+750,-0.004020403,0.002972602,0.02924637
+751,-0.004136776,-0.002808396,0.0282485
+752,-0.004125905,0.002824341,0.01050293
+753,-0.00411877,-0.002834738,0.0306869
+754,-0.003673134,-0.003392357,0.01598985
+755,-0.001455413,-0.00478349,0.01851659
+756,-0.004304298,-0.002544212,0.03545128
+757,-0.00363465,0.003433558,0.01750852
+758,-0.003251533,-0.00379836,0.01831934
+759,-0.00498552,0.000380251,0.03801988
+760,-0.004051273,-0.00293039,0.02041098
+761,-0.004964982,0.0005907242,0.01051776
+762,-0.004323081,0.002512165,0.0380246
+763,-0.004497383,-0.002184845,0.0140051
+764,-0.00445319,0.002273566,0.01992417
+765,-0.004942971,-0.0007530163,0.01228195
+766,-0.004206763,-0.002702434,0.03307467
+767,-0.004988144,-0.0003441144,0.0340069
+768,-0.00491241,0.0009317896,0.01738947
+769,-0.00466504,0.001799277,0.02703294
+770,-0.004967895,-0.0005657048,0.03621085
+771,-0.004999866,0.00003667389,0.02949429
+772,-0.004998346,0.0001286071,0.02482189
+773,-0.004677553,0.001766493,0.01253644
+774,-0.004856149,0.001190721,0.02243824
+775,-0.004988683,-0.0003362126,0.02025025
+776,-0.004985463,0.0003809953,0.01453499
+777,-0.004827581,-0.001301716,0.01606022
+778,-0.004946691,-0.0007281818,0.0270983
+779,-0.004938159,-0.0007839554,0.03181067
+780,-0.00463431,-0.001877012,0.01818715
+781,0.005844431,0.001357432,0.04905513
+782,0.005501935,0.002393473,0.04901401
+783,0.004999928,0.003316734,0.04896936
+784,0.004351123,0.004131311,0.04895931
+785,0.00358102,0.004814176,0.04901523
+786,0.002668722,0.005373818,0.04901063
+787,0.001742285,0.005741467,0.04894846
+788,0.0007125666,0.005957537,0.04896401
+789,-0.0003319253,0.005990812,0.04898032
+790,-0.001353922,0.005845245,0.04897595
+791,-0.002350304,0.005520514,0.04892185
+792,-0.003270757,0.005030124,0.04890932
+793,-0.004061374,0.004416474,0.04892399
+794,-0.004748689,0.003667418,0.04900356
+795,-0.005302369,0.002808003,0.04902072
+796,-0.005698478,0.001878123,0.04896891
+797,-0.005931624,0.0009032351,0.0489981
+798,-0.005998349,-0.0001407527,0.04898694
+799,-0.005891407,-0.001136363,0.04892667
+800,-0.00561525,-0.002113993,0.04893197
+801,-0.005176387,-0.003033978,0.04895862
+802,-0.004579344,-0.003876803,0.0489659
+803,-0.003850011,-0.004601893,0.04894552
+804,-0.003024373,-0.005182004,0.04893857
+805,-0.002101204,-0.005620048,0.04893739
+806,-0.001123035,-0.005893962,0.04893139
+807,-0.0001415883,-0.005998329,0.04895632
+808,0.0008791922,-0.005935236,0.04894923
+809,0.0018441,-0.005709579,0.04892128
+810,0.002733089,-0.005341369,0.04901206
+811,0.003591423,-0.004806421,0.04907472
+812,0.004344319,-0.004138465,0.04904816
+813,0.004943756,-0.003399894,0.04911143
+814,0.005438801,-0.002533663,0.04911917
+815,0.005758418,-0.001685414,0.04913489
+816,0.005950192,-0.0007715024,0.04911401
+817,0.005950952,-0.0007656187,0.001786144
+818,0.005909924,-0.001035761,0.003910235
+819,0.005903004,-0.0010745,0.006155027
+820,0.00590117,-0.001084523,0.008399617
+821,0.005930083,-0.0009132972,0.01054821
+822,0.005923012,-0.0009580864,0.01276331
+823,0.005862036,-0.001279272,0.01498661
+824,0.005888024,-0.001153762,0.01734296
+825,0.005907485,-0.001049582,0.0193909
+826,0.005864326,-0.001268732,0.02145256
+827,0.005861855,-0.001280098,0.0238354
+828,0.005929681,-0.0009159035,0.02606632
+829,0.005928291,-0.0009248629,0.02828696
+830,0.005866528,-0.001258509,0.03047074
+831,0.005885755,-0.001165283,0.03279679
+832,0.005854986,-0.00131116,0.0349592
+833,0.00588715,-0.001158218,0.03712708
+834,0.005871493,-0.001235138,0.03949058
+835,0.005885217,-0.001168001,0.04163171
+836,0.005881636,-0.0011859,0.04375029
+837,0.005930487,-0.0009106727,0.04603159
+838,0.005970296,-0.000596296,0.04818794
+839,0.005855763,0.001307686,0.0009359286
+840,0.00498219,0.003343319,0.001119184
+841,0.003442029,0.004914513,0.001198843
+842,0.0016754,0.00576134,0.0008340869
+843,-0.0002858611,0.005993186,0.001182665
+844,-0.002358851,0.005516867,0.001244083
+845,-0.004021893,0.004452458,0.0008597908
+846,-0.005320766,0.002772985,0.001402434
+847,-0.005938289,0.0008583265,0.001316335
+848,-0.005880848,-0.001189802,0.0009131494
+849,-0.005278035,-0.00285348,0.001269229
+850,-0.003922505,-0.004540259,0.001241347
+851,-0.002083487,-0.00562664,0.001207731
+852,-0.0002014448,-0.005996617,0.001228501
+853,0.001885732,-0.005695965,0.001298389
+854,0.003717599,-0.004709507,0.001063326
+855,0.004965653,-0.003367831,0.001039951
+856,0.005849324,-0.001336194,0.0009137322
+857,0.005953152,0.0007483162,0.001764965
+858,0.005937116,0.0008664031,0.002746376
+859,0.005921732,0.0009659689,0.003838415
+860,0.005917016,0.0009944459,0.004971479
+861,0.005908169,0.001045726,0.006083476
+862,0.005906144,0.001057099,0.007203296
+863,0.005907262,0.001050834,0.008335784
+864,0.00591556,0.001003072,0.009423507
+865,0.005916247,0.0009990117,0.01053158
+866,0.005910111,0.001034694,0.01167169
+867,0.005905625,0.001059994,0.01278789
+868,0.005900536,0.001087966,0.01386923
+869,0.005902729,0.001076008,0.01497872
+870,0.005906082,0.001057446,0.01610519
+871,0.005912231,0.00102251,0.01719649
+872,0.005910542,0.001032228,0.01831038
+873,0.005906787,0.001053504,0.01943041
+874,0.005910471,0.001032636,0.02055277
+875,0.005908809,0.0010421,0.02165177
+876,0.00590656,0.001054776,0.02276035
+877,0.005905073,0.001063065,0.02388153
+878,0.005912127,0.001023111,0.02495501
+879,0.005913943,0.001012559,0.02606489
+880,0.005911461,0.001026953,0.02719354
+881,0.005912909,0.001018579,0.02830702
+882,0.005911568,0.001026336,0.02939844
+883,0.005910565,0.001032097,0.03050858
+884,0.005909341,0.001039082,0.03163361
+885,0.005911477,0.001026859,0.03272326
+886,0.005905907,0.001058427,0.03384002
+887,0.00590055,0.00108789,0.03496896
+888,0.005907791,0.001047859,0.03605865
+889,0.005908528,0.001043693,0.03717102
+890,0.005911463,0.00102694,0.03828978
+891,0.005911457,0.001026972,0.0394221
+892,0.005916194,0.0009993261,0.04051958
+893,0.005909763,0.001036676,0.04166452
+894,0.005910686,0.001031403,0.04276854
+895,0.005906245,0.001056538,0.04389599
+896,0.005912966,0.001018249,0.04503932
+897,0.005921784,0.0009656464,0.04616963
+898,0.005932936,0.000894576,0.04724059
+899,0.005951778,0.0007591724,0.04820142
+900,0.005924741,-0.0009473334,0.002799464
+901,0.005905482,-0.001060791,0.005022217
+902,0.005899757,-0.001092183,0.007248143
+903,0.005898956,-0.001096504,0.009508014
+904,0.005855525,-0.00130875,0.01163963
+905,0.005880636,-0.001190848,0.01381748
+906,0.005864336,-0.001268685,0.01618381
+907,0.005943314,-0.0008228096,0.01834324
+908,0.00592312,-0.0009574168,0.02045057
+909,0.005854259,-0.001314401,0.02263354
+910,0.005887814,-0.001154834,0.025002
+911,0.005862893,-0.001275337,0.02717035
+912,0.005888104,-0.001153355,0.02932986
+913,0.005866245,-0.00125983,0.03164596
+914,0.005926785,-0.0009344636,0.03385023
+915,0.005925482,-0.0009426862,0.03606977
+916,0.005867892,-0.001252135,0.03829371
+917,0.005919703,-0.0009783223,0.04055473
+918,0.005921753,-0.0009658391,0.04270239
+919,0.005895308,-0.001115952,0.04492173
+920,0.005870551,-0.001239607,0.04712585
+921,0.00551309,0.002367665,0.001007636
+922,0.004280542,0.004204398,0.001179286
+923,0.002528382,0.005441258,0.001105002
+924,0.0007634173,0.005951235,0.001085997
+925,-0.001358368,0.005844214,0.001239586
+926,-0.003266957,0.005032593,0.001052672
+927,-0.004697302,0.003733009,0.001479335
+928,-0.005706991,0.001852094,0.001105243
+929,-0.005995276,-0.0002380529,0.001256828
+930,-0.005647507,-0.002026243,0.0009089864
+931,-0.004679851,-0.003754863,0.001323858
+932,-0.003026462,-0.005180784,0.001212837
+933,-0.001157234,-0.005887343,0.000990389
+934,0.0008526054,-0.005939113,0.001300271
+935,0.002841105,-0.005284707,0.001185726
+936,0.004380327,-0.004100333,0.000846669
+937,0.005499886,-0.002398176,0.001009732
+938,0.005351844,0.00271252,0.04792096
+939,0.004751258,0.003664089,0.04784055
+940,0.003996674,0.004475109,0.04783514
+941,0.003186873,0.005083683,0.04804623
+942,0.002329032,0.005529522,0.04778995
+943,0.001311114,0.005854996,0.04775085
+944,0.0002450652,0.005994993,0.04784919
+945,-0.0008495891,0.005939545,0.04786104
+946,-0.001876362,0.005699058,0.04776683
+947,-0.002851275,0.005279227,0.04770211
+948,-0.003743028,0.004689322,0.04767512
+949,-0.004502456,0.00396584,0.04775167
+950,-0.005066006,0.0032149,0.04801572
+951,-0.005518167,0.002355808,0.04785369
+952,-0.005845342,0.001353504,0.04782106
+953,-0.005986891,0.0003964086,0.04799323
+954,-0.00597422,-0.0005556065,0.04772451
+955,-0.005789774,-0.00157433,0.04776011
+956,-0.005416285,-0.002581445,0.04780777
+957,-0.004906489,-0.003453457,0.04785678
+958,-0.004225956,-0.00425926,0.04783569
+959,-0.003450735,-0.004908404,0.04775455
+960,-0.002567815,-0.00542276,0.04780571
+961,-0.001562944,-0.005792858,0.04779624
+962,-0.0005506559,-0.005974678,0.04772112
+963,0.0004045609,-0.005986345,0.04791953
+964,0.00138376,-0.005838254,0.04766763
+965,0.002396805,-0.005500484,0.04770021
+966,0.00323032,-0.005056188,0.04805656
+967,0.004003803,-0.004468732,0.04795993
+968,0.004711443,-0.003715145,0.04798969
+969,0.005216305,-0.00296482,0.04821551
+970,0.005609122,-0.0021302,0.04805081
+971,0.005847669,-0.001343416,0.04834092
+972,0.004705996,0.003722043,0.002352087
+973,0.005602831,-0.002146692,0.01040337
+974,0.005478411,-0.002446838,0.006717177
+975,0.005494681,-0.002410079,0.009055651
+976,0.00560445,-0.00214246,0.005590097
+977,0.005582273,-0.002199598,0.007863892
+978,0.005566172,-0.002240028,0.01279809
+979,0.005296469,-0.002819117,0.01565078
+980,0.005410164,-0.002594249,0.01712879
+981,0.005629662,-0.002075308,0.01849116
+982,0.005505752,-0.00238468,0.02009331
+983,0.005306755,-0.002799706,0.02316542
+984,0.005420424,-0.002572742,0.02457893
+985,0.005602991,-0.002146273,0.02594687
+986,0.005601195,-0.002150957,0.02833682
+987,0.005357631,-0.002701072,0.03102452
+988,0.005415985,-0.002582074,0.0324098
+989,0.005584367,-0.002194275,0.03376593
+990,0.005584109,-0.002194932,0.03615398
+991,0.005395781,-0.002624033,0.03902973
+992,0.005481652,-0.002439568,0.04069704
+993,0.005500871,-0.002395917,0.04259904
+994,0.005600858,-0.002151833,0.04579689
+995,0.0004661154,0.005981867,0.002512889
+996,0.002695368,0.005360503,0.002526069
+997,0.005537013,-0.002311165,0.004448428
+998,0.001627496,0.005775055,0.002049038
+999,0.005358113,0.002700116,0.002170782
+1000,-0.00573056,0.00177783,0.002744483
+1001,0.003778634,0.004660678,0.002551248
+1002,-0.003066505,0.005157184,0.002505195
+1003,-0.005803093,-0.001524505,0.002329601
+1004,-0.005997702,0.0001660462,0.002735691
+1005,0.005765226,0.001661978,0.001989195
+1006,-0.005204508,-0.002985481,0.002793583
+1007,-0.003473866,-0.00489206,0.002468544
+1008,-0.001189962,-0.005880815,0.002426455
+1009,0.002648381,-0.005383872,0.002701869
+1010,0.004444722,-0.00403044,0.002160897
+1011,0.005221655,-0.002955388,0.002193666
+1012,0.005717193,-0.001820359,0.002001684
+1013,0.005759205,0.001682723,0.0480551
+1014,0.005705337,0.001857184,0.003104199
+1015,0.005654344,0.002007087,0.004241974
+1016,0.00560315,0.002145859,0.005431887
+1017,0.005575729,0.002216134,0.006608191
+1018,0.005580032,0.002205277,0.007740574
+1019,0.00558876,0.002183064,0.008886982
+1020,0.005604252,0.00214298,0.009958416
+1021,0.005620122,0.002101008,0.01108274
+1022,0.005583519,0.002196431,0.01221215
+1023,0.005531206,0.00232503,0.01329394
+1024,0.005554973,0.002267658,0.01439596
+1025,0.005571183,0.002227538,0.01554015
+1026,0.005583071,0.002197571,0.01663237
+1027,0.005587547,0.002186166,0.01776835
+1028,0.005570184,0.002230034,0.0188749
+1029,0.005590365,0.002178949,0.01998148
+1030,0.005591011,0.002177292,0.02111716
+1031,0.005584056,0.002195067,0.02219698
+1032,0.005575478,0.002216764,0.02332794
+1033,0.005560837,0.002253239,0.0244183
+1034,0.005594727,0.002167725,0.02550857
+1035,0.005606539,0.002136989,0.02664508
+1036,0.005600413,0.002152991,0.02773234
+1037,0.005597928,0.002159445,0.02884573
+1038,0.005602348,0.002147952,0.02992287
+1039,0.005596862,0.002162207,0.03105354
+1040,0.005589722,0.002180599,0.03213856
+1041,0.005573171,0.002222558,0.03326947
+1042,0.005537044,0.002311092,0.03438718
+1043,0.005539488,0.002305227,0.03551717
+1044,0.00558383,0.002195641,0.03662185
+1045,0.005596287,0.002163694,0.03776464
+1046,0.005605898,0.002138671,0.03885268
+1047,0.005606934,0.002135953,0.03998814
+1048,0.005601998,0.002148864,0.04108311
+1049,0.005589077,0.002182252,0.0422479
+1050,0.005572926,0.002223173,0.04339977
+1051,0.005586682,0.002188374,0.044598
+1052,0.005639727,0.002047798,0.04580409
+1053,0.005698113,0.00187923,0.04694239
+1054,-0.005089277,0.003177933,0.003185615
+1055,0.005217819,-0.002962156,0.03495136
+1056,0.005229291,-0.002941855,0.01151919
+1057,0.005292073,-0.00282736,0.02711534
+1058,0.00538183,-0.002652529,0.014172
+1059,0.005324149,-0.002766484,0.02162669
+1060,0.005415374,-0.002583355,0.02966426
+1061,0.00542811,-0.002556486,0.0375391
+1062,0.005464619,-0.002477486,0.04429735
+1063,-0.0007386868,0.005954355,0.002479489
+1064,-0.001870123,0.005701109,0.002830266
+1065,-0.00412462,0.004357466,0.003294318
+1066,-0.003880456,0.004576249,0.001905728
+1067,-0.002449301,-0.00547731,0.002666797
+1068,-0.00435444,-0.004127814,0.002781546
+1069,0.0001714637,-0.00599755,0.002656333
+1070,0.001457606,-0.005820256,0.002789671
+1071,0.003558153,-0.004831102,0.002262525
+1072,0.005614186,-0.002116818,0.003213287
+1073,0.004417767,0.004059967,0.04655381
+1074,0.003294257,0.005014765,0.04663361
+1075,0.002101885,0.005619794,0.04636315
+1076,0.000811987,0.005944803,0.04641455
+1077,-0.0002718113,0.00599384,0.04670385
+1078,-0.001296216,0.005858312,0.04647194
+1079,-0.002363801,0.005514748,0.04632137
+1080,-0.003371522,0.004963148,0.04627872
+1081,-0.004366935,0.004114593,0.04630516
+1082,-0.005166152,0.003051373,0.0465068
+1083,-0.005722761,0.001802778,0.0465768
+1084,-0.005983268,0.0004477766,0.04646329
+1085,-0.005926119,-0.0009386741,0.04621088
+1086,-0.005637824,-0.002053032,0.04658823
+1087,-0.005168876,-0.003046755,0.04639958
+1088,-0.004602163,-0.003849687,0.04668464
+1089,-0.003912466,-0.004548913,0.04635766
+1090,-0.002971073,-0.005212746,0.04636432
+1091,-0.002025379,-0.005647817,0.04664729
+1092,-0.0009472794,-0.00592475,0.04633359
+1093,0.0004719633,-0.005981409,0.04634897
+1094,0.002053099,-0.0056378,0.04613377
+1095,0.003413919,-0.004934081,0.04659964
+1096,0.004513313,-0.003953481,0.04686769
+1097,0.005285074,-0.002840422,0.04695152
+1098,0.001481494,0.005814222,0.003830095
+1099,-0.005585174,-0.002192221,0.004789719
+1100,0.004801593,-0.003597875,0.005616727
+1101,0.004149511,-0.004333769,0.03003642
+1102,0.004772601,-0.003636246,0.01853076
+1103,0.00441073,-0.004067612,0.03801349
+1104,0.004270804,-0.004214289,0.02411633
+1105,0.004767297,-0.003643197,0.02853328
+1106,0.004767509,-0.003642919,0.02561135
+1107,0.004219559,-0.004265598,0.01671609
+1108,0.004543415,-0.003918849,0.04168471
+1109,0.004707594,-0.003720022,0.03348972
+1110,0.00441417,-0.004063878,0.03987128
+1111,0.004718401,-0.003706304,0.03641529
+1112,-0.004378499,0.004102285,0.005265849
+1113,0.004297982,-0.004186568,0.02025808
+1114,0.004772278,-0.003636669,0.009847111
+1115,0.005214152,0.002968606,0.04671663
+1116,0.004098438,-0.004382101,0.02218654
+1117,0.005117739,0.003131892,0.004663576
+1118,0.00498095,0.003345166,0.005936942
+1119,0.004843966,0.00354062,0.007185376
+1120,0.004997738,0.003320033,0.008344732
+1121,0.00486526,0.003511303,0.009494675
+1122,0.005106105,0.003150824,0.01051569
+1123,0.00507033,0.003208077,0.01152698
+1124,0.004764137,0.003647328,0.01255947
+1125,0.004730187,0.003691251,0.01383879
+1126,0.004955541,0.003382693,0.01497455
+1127,0.004821744,0.003570825,0.0160932
+1128,0.005001564,0.003314266,0.01719187
+1129,0.004865213,0.003511367,0.01829513
+1130,0.004873758,0.003499497,0.01949477
+1131,0.005021071,0.003284638,0.02057287
+1132,0.004843455,0.00354132,0.02165875
+1133,0.00498941,0.003332535,0.0227524
+1134,0.004801564,0.003597914,0.02385412
+1135,0.004880829,0.003489629,0.02506706
+1136,0.005102656,0.003156407,0.02611959
+1137,0.004959134,0.003377423,0.02720706
+1138,0.005067465,0.0032126,0.0282874
+1139,0.004942033,0.003402398,0.02936291
+1140,0.005099042,0.003162242,0.03044541
+1141,0.004899666,0.003463131,0.03149183
+1142,0.004986066,0.003337535,0.03260088
+1143,0.004812851,0.003582801,0.0336782
+1144,0.0047658,0.003645155,0.03494734
+1145,0.004816189,0.003578313,0.03619873
+1146,0.005052062,0.003236768,0.03728577
+1147,0.004946009,0.003396616,0.03836946
+1148,0.005107693,0.00314825,0.03943038
+1149,0.004949868,0.00339099,0.04051196
+1150,0.005084026,0.003186328,0.04163274
+1151,0.0049045,0.003456282,0.04276523
+1152,0.004946112,0.003396465,0.04411609
+1153,0.005070067,0.003208491,0.04543721
+1154,0.005226335,0.002947104,0.00341663
+1155,-0.002682659,0.005366875,0.004806625
+1156,0.004607417,-0.003843398,0.01294648
+1157,-0.0004844606,0.00598041,0.004425966
+1158,0.004949371,-0.003391714,0.003662753
+1159,0.004724461,-0.003698576,0.04536368
+1160,0.00433858,-0.004144481,0.03187059
+1161,0.004420747,0.004056722,0.0037076
+1162,0.004593725,-0.003859752,0.04355009
+1163,0.004703638,-0.003725022,0.007846306
+1164,-0.003444317,-0.004912909,0.004240099
+1165,0.002384539,-0.005505813,0.004619665
+1166,-0.005956821,-0.0007185289,0.004216132
+1167,-0.0005397123,-0.005975677,0.004089152
+1168,-0.004736657,-0.003682944,0.004744776
+1169,0.000859135,-0.005938172,0.004575844
+1170,-0.005940101,0.0008456918,0.004867433
+1171,-0.005460649,0.002486225,0.005112254
+1172,-0.001907226,-0.005688804,0.004431418
+1173,-0.003339235,0.004984928,0.00723813
+1174,0.002349334,-0.005520927,0.02332918
+1175,0.002861381,0.005273756,0.04473679
+1176,-0.003961017,0.0045067,0.04465876
+1177,-0.00575246,0.001705639,0.04458715
+1178,-0.005559949,-0.00225543,0.04455829
+1179,0.002676636,-0.005369881,0.01830863
+1180,0.004145715,-0.004337401,0.01467899
+1181,0.00233186,-0.00552833,0.02086136
+1182,0.003811369,-0.004633947,0.03492164
+1183,0.003804219,-0.004639819,0.004015444
+1184,0.003280797,-0.005023582,0.006708936
+1185,0.003033864,-0.005176453,0.0332384
+1186,-0.00514576,-0.003085636,0.007199421
+1187,0.004185771,-0.004298759,0.0269841
+1188,0.00292234,-0.005240222,0.009556004
+1189,0.003043623,0.005170721,0.004396374
+1190,0.003120269,-0.005124834,0.04276798
+1191,-0.0008730363,0.005936144,0.007297582
+1192,-0.005837111,0.001388573,0.007192095
+1193,0.002276576,-0.005551324,0.01548176
+1194,0.002495266,-0.005456523,0.0313265
+1195,0.001629577,0.005774468,0.006411395
+1196,0.003684446,0.004735489,0.00641341
+1197,0.003368202,0.004965402,0.01297528
+1198,0.003679278,0.004739506,0.01714395
+1199,0.003711315,0.004714461,0.02065821
+1200,0.003699995,0.004723351,0.02827224
+1201,0.003520178,0.004858842,0.03228527
+1202,0.003880298,0.004576383,0.03749061
+1203,0.003967274,0.004501193,0.04149514
+1204,0.003892777,0.004565774,0.04335862
+1205,0.004136707,0.004345993,0.0451268
+1206,0.004287741,0.004197056,0.005074894
+1207,0.001350702,0.00584599,0.04459382
+1208,-0.0002436273,0.005995052,0.04500143
+1209,-0.001659116,0.00576605,0.04496498
+1210,-0.002818173,0.005296971,0.04443422
+1211,-0.004955643,0.003382544,0.04433491
+1212,-0.005992042,-0.0003089164,0.04424317
+1213,-0.004666511,-0.003771429,0.04500504
+1214,-0.0035107,-0.004865695,0.04444059
+1215,-0.002066342,-0.005632959,0.04508461
+1216,-0.0005435168,-0.005975332,0.04435806
+1217,0.001354282,-0.005845162,0.04403212
+1218,0.003307587,-0.005005983,0.04466176
+1219,0.002628097,-0.005393803,0.03867827
+1220,-0.003988554,-0.004482348,0.006324289
+1221,0.002849442,-0.005280216,0.04071129
+1222,0.004006259,-0.004466529,0.01133182
+1223,0.002805541,-0.005303672,0.02569495
+1224,0.00212877,-0.005609665,0.02950264
+1225,0.003687044,0.004733466,0.008408043
+1226,0.003887695,0.004570101,0.01083365
+1227,0.003608107,0.004793909,0.01507265
+1228,0.003781244,0.004658561,0.01891441
+1229,0.003531062,0.004850938,0.02461075
+1230,0.003652453,0.004760209,0.02267351
+1231,0.00405776,0.004419795,0.02628929
+1232,0.004029644,0.004445444,0.03034704
+1233,0.003625393,0.00478085,0.03410985
+1234,0.003391328,0.004949636,0.03572099
+1235,0.004002179,0.004470186,0.03948428
+1236,-0.004960456,0.003375482,0.007365087
+1237,-0.002441354,-0.005480857,0.006506989
+1238,0.00007632272,-0.005999515,0.01939967
+1239,0.002570879,-0.005421308,0.01270675
+1240,-0.003542745,-0.004842412,0.008555554
+1241,0.0003113778,-0.005991915,0.02485004
+1242,0.00003707479,-0.005999885,0.02213373
+1243,0.00303685,-0.005174702,0.0366758
+1244,0.0007484064,-0.005953141,0.03275035
+1245,0.003088735,-0.005143901,0.02804572
+1246,-0.00594966,-0.0007755944,0.006700064
+1247,-0.002431087,0.005485419,0.009223438
+1248,0.0003319778,-0.005990809,0.03037714
+1249,0.001445569,-0.005823258,0.006198371
+1250,-0.0004877276,-0.005980144,0.006249656
+1251,-0.0000547139,-0.005999751,0.01657704
+1252,-0.0057106,-0.001840936,0.009015421
+1253,0.00001632357,-0.005999978,0.0136638
+1254,0.0004571813,-0.005982557,0.01081362
+1255,-0.00599674,0.0001977486,0.009376445
+1256,-0.00130398,-0.005856589,0.008763922
+1257,0.001633736,0.005773293,0.009115212
+1258,0.0007233775,-0.005956234,0.03713545
+1259,0.0004113407,-0.005985883,0.03976212
+1260,0.001682159,-0.00575937,0.034955
+1261,0.001445834,0.005823192,0.02400049
+1262,0.0006526128,-0.005964402,0.02757381
+1263,0.002196358,0.005583548,0.04257205
+1264,0.001689012,0.005757364,0.01156193
+1265,-0.004178202,0.004306115,0.009597338
+1266,-0.000505059,0.005978705,0.0102188
+1267,0.0009875601,0.005918169,0.03192696
+1268,0.00120415,0.005877927,0.02813338
+1269,0.001081913,-0.005901649,0.008270336
+1270,-0.004747771,-0.003668606,0.01026281
+1271,0.001443587,0.005823749,0.01635093
+1272,0.00161881,0.005777495,0.03663974
+1273,-0.005526419,0.002336384,0.009616305
+1274,0.0002864986,0.005993156,0.04314144
+1275,-0.001595911,0.005783863,0.0428689
+1276,-0.003728301,0.00470104,0.0425285
+1277,-0.001065489,-0.005904637,0.03473789
+1278,-0.005259547,0.002887414,0.04223457
+1279,-0.005948717,0.0007827949,0.04216365
+1280,-0.005768693,-0.001649903,0.04210322
+1281,-0.00446709,-0.004005635,0.04230862
+1282,-0.002327599,-0.005530125,0.04298148
+1283,-0.0004252164,-0.005984914,0.04219325
+1284,0.00145052,-0.005822026,0.04184976
+1285,0.00144971,0.005822228,0.02156794
+1286,0.001711476,0.005750726,0.0189608
+1287,-0.0008737451,0.00593604,0.01769731
+1288,0.00005688765,0.00599973,0.0411631
+1289,-0.002521191,-0.005444593,0.01147532
+1290,0.002360283,0.005516255,0.03850074
+1291,-0.005568515,0.002234198,0.03995222
+1292,0.00146575,0.005818211,0.01400611
+1293,0.00214402,0.005603854,0.04039307
+1294,-0.005796147,-0.001550704,0.01158914
+1295,-0.005372779,-0.002670813,0.03956086
+1296,0.002158333,0.005598357,0.0301331
+1297,-0.002575522,-0.005419104,0.01489412
+1298,-0.001098441,0.005898595,0.02307289
+1299,-0.001668426,-0.005763363,0.03178731
+1300,-0.002489157,-0.005459313,0.0178565
+1301,0.002187122,0.005587173,0.02624904
+1302,-0.0008929997,0.005933174,0.02974318
+1303,-0.0007988534,0.005946582,0.02619582
+1304,-0.001258491,0.005866532,0.01483905
+1305,-0.0009682169,0.005921364,0.02031751
+1306,-0.00008484815,0.0059994,0.03863447
+1307,0.001516962,0.005805069,0.03419116
+1308,-0.001967291,-0.005668312,0.02632889
+1309,-0.001948573,-0.005674774,0.03786068
+1310,-0.001856907,-0.005705427,0.0290375
+1311,-0.002169565,-0.005594014,0.02355205
+1312,-0.002338191,-0.005525655,0.02079432
+1313,-0.001290198,0.005859641,0.03296657
+1314,-0.002783948,0.005315039,0.01192827
+1315,-0.0003906863,0.005987267,0.01257341
+1316,-0.002161713,-0.005597053,0.04068604
+1317,-0.0008855807,0.005934286,0.03579145
+1318,-0.005916483,0.0009976134,0.01207536
+1319,-0.004306272,-0.00417804,0.02230312
+1320,-0.002221339,0.005573657,0.04050342
+1321,-0.003477748,0.004889301,0.02777259
+1322,-0.004160327,-0.004323387,0.02509449
+1323,-0.00385322,-0.004599206,0.03963069
+1324,-0.003446448,0.004911415,0.03110292
+1325,-0.005998689,-0.0001254388,0.03991163
+1326,-0.005797724,0.001544798,0.03762753
+1327,-0.004910728,0.003447426,0.01208346
+1328,-0.004229724,0.004255518,0.04010216
+1329,-0.004691958,-0.003739723,0.01637573
+1330,-0.004274172,-0.004210873,0.03744513
+1331,-0.003524751,0.004855526,0.03462374
+1332,-0.003516596,0.004861435,0.02454523
+1333,-0.003582611,-0.004812993,0.03316309
+1334,-0.00450016,-0.003968446,0.01941964
+1335,-0.002749798,0.005332786,0.03782019
+1336,-0.00596167,-0.0006771171,0.03767631
+1337,-0.002916992,0.005243201,0.0165777
+1338,-0.005931282,-0.000905478,0.01483116
+1339,-0.004061902,-0.004415988,0.02782414
+1340,-0.004710818,-0.003715938,0.01327506
+1341,-0.003400532,0.004943317,0.02154925
+1342,-0.003895479,-0.004563468,0.03049554
+1343,-0.00541839,-0.002577024,0.03712054
+1344,-0.003926833,0.004536517,0.01442104
+1345,-0.003276912,-0.005026116,0.03557728
+1346,-0.004723139,0.003700265,0.03753198
+1347,-0.00317782,0.005089348,0.01887668
+1348,-0.005286204,0.002838317,0.02929389
+1349,-0.005230596,0.002939534,0.0225071
+1350,-0.004749695,0.003666115,0.01697815
+1351,-0.005583242,0.002197137,0.0146989
+1352,-0.005445134,0.002520023,0.02577059
+1353,-0.005132586,0.003107501,0.03230808
+1354,-0.005833959,-0.001401755,0.0356528
+1355,-0.005333041,0.002749305,0.03517365
+1356,-0.005573125,-0.002222674,0.02393081
+1357,-0.004989554,-0.003332319,0.0348143
+1358,-0.00570557,-0.001856467,0.02118667
+1359,-0.005813816,-0.001483086,0.01820924
+1360,-0.005969374,0.0006054524,0.03553624
+1361,-0.005296322,-0.002819393,0.03199587
+1362,-0.005052895,0.003235468,0.01963863
+1363,-0.005506935,-0.002381947,0.0266472
+1364,-0.00598107,0.0004762427,0.02312714
+1365,-0.005855421,0.001309214,0.01742608
+1366,-0.005501513,-0.002394443,0.02932369
+1367,-0.005994227,0.0002631321,0.03097299
+1368,-0.005939537,0.0008496478,0.02035522
+1369,-0.005916636,-0.0009967063,0.03353582
+1370,-0.005995471,0.000233089,0.02803599
+1371,-0.005860258,0.001287393,0.03339616
+1372,-0.00599679,-0.0001962463,0.02548954
+1373,0.005447819,-0.000367903,0.0293814
+1374,0.005458275,0.0003286152,0.04943852
+1375,0.005476626,0.0001205782,0.0005799493
+1376,0.005437623,-0.0003558839,0.04164568
+1377,0.005434457,-0.0008155921,0.03221323
+1378,0.00597472,0.0005501984,0.05
+1379,0.005783321,0.001597872,0.05
+1380,0.005432824,0.002546453,0.05
+1381,0.004938484,0.003407547,0.05
+1382,0.004308904,0.004175326,0.05
+1383,0.003539045,0.004845117,0.05
+1384,0.002647879,0.005384119,0.05
+1385,0.001703449,0.005753109,0.05
+1386,0.0006795028,0.005961399,0.05
+1387,-0.0003650527,0.005988884,0.05
+1388,-0.001347719,0.005846679,0.05
+1389,-0.00231616,0.005534926,0.05
+1390,-0.003235816,0.005052672,0.05
+1391,-0.00404042,0.004435652,0.05
+1392,-0.004739369,0.003679455,0.05
+1393,-0.005303037,0.002806742,0.05
+1394,-0.005696204,0.00188501,0.05
+1395,-0.005930688,0.000909363,0.05
+1396,-0.005998274,-0.0001439095,0.05
+1397,-0.005882345,-0.001182376,0.05
+1398,-0.005606809,-0.002136281,0.05
+1399,-0.005176178,-0.003034334,0.05
+1400,-0.004579199,-0.003876976,0.05
+1401,-0.003848926,-0.0046028,0.05
+1402,-0.003025402,-0.005181404,0.05
+1403,-0.002112243,-0.005615909,0.05
+1404,-0.001152443,-0.005888283,0.05
+1405,-0.0001655884,-0.005997715,0.05
+1406,0.0008258002,-0.005942899,0.05
+1407,0.001794574,-0.005725339,0.05
+1408,0.002718913,-0.005348599,0.05
+1409,0.003580336,-0.004814685,0.05
+1410,0.004335959,-0.004147223,0.05
+1411,0.004976029,-0.003352482,0.05
+1412,0.005472167,-0.00246077,0.05
+1413,0.005809254,-0.001500854,0.05
+1414,0.005979371,-0.0004971184,0.05
+1415,0.006,-1.469576E-018,0.0005890884
+1416,0.006,-1.469576E-018,0.001698279
+1417,0.006,-1.469576E-018,0.00275513
+1418,0.006,-1.469576E-018,0.003926259
+1419,0.006,-1.469576E-018,0.005058963
+1420,0.006,-1.469576E-018,0.006108357
+1421,0.006,-1.469576E-018,0.007212742
+1422,0.006,-1.469576E-018,0.008352902
+1423,0.006,-1.469576E-018,0.009460972
+1424,0.006,-1.469576E-018,0.01051894
+1425,0.006,-1.469576E-018,0.01168895
+1426,0.006,-1.469576E-018,0.01282053
+1427,0.006,-1.469576E-018,0.01386993
+1428,0.006,-1.469576E-018,0.01497656
+1429,0.006,-1.469576E-018,0.01611672
+1430,0.006,-1.469576E-018,0.01722367
+1431,0.006,-1.469576E-018,0.01828276
+1432,0.006,-1.469576E-018,0.01945164
+1433,0.006,-1.469576E-018,0.02058211
+1434,0.006,-1.469576E-018,0.0216315
+1435,0.006,-1.469576E-018,0.02274037
+1436,0.006,-1.469576E-018,0.02388053
+1437,0.006,-1.469576E-018,0.02498636
+1438,0.006,-1.469576E-018,0.02604657
+1439,0.006,-1.469576E-018,0.02721434
+1440,0.006,-1.469576E-018,0.02834368
+1441,0.006,-1.469576E-018,0.02939307
+1442,0.006,-1.469576E-018,0.03050418
+1443,0.006,-1.469576E-018,0.03164434
+1444,0.006,-1.469576E-018,0.03274905
+1445,0.006,-1.469576E-018,0.03381039
+1446,0.006,-1.469576E-018,0.03497703
+1447,0.006,-1.469576E-018,0.03610525
+1448,0.006,-1.469576E-018,0.03715464
+1449,0.006,-1.469576E-018,0.038268
+1450,0.006,-1.469576E-018,0.03940816
+1451,0.006,-1.469576E-018,0.04051174
+1452,0.006,-1.469576E-018,0.04164492
+1453,0.006,-1.469576E-018,0.04275072
+1454,0.006,-1.469576E-018,0.04380011
+1455,0.006,-1.469576E-018,0.04495133
+1456,0.006,-1.469576E-018,0.04609149
+1457,0.006,-1.469576E-018,0.04717614
+1458,0.006,-1.469576E-018,0.04825269
+1459,0.006,-1.469576E-018,0.0493923
+1460,0.005974874,0.0005485208,0
+1461,0.0057842,0.001594687,0
+1462,0.00543417,0.002543579,0
+1463,0.004940211,0.003405042,0
+1464,0.004310929,0.004173235,0
+1465,0.00354129,0.004843476,0
+1466,0.002650257,0.005382949,0
+1467,0.001705865,0.005752393,0
+1468,0.000681876,0.005961128,0
+1469,-0.0003627989,0.005989021,0
+1470,-0.001345646,0.005847156,0
+1471,-0.002314318,0.005535696,0
+1472,-0.003234245,0.005053678,0
+1473,-0.004039137,0.00443682,0
+1474,-0.004738385,0.003680721,0
+1475,-0.005302348,0.002808044,0
+1476,-0.005695782,0.001886284,0
+1477,-0.005930504,0.0009105607,0
+1478,-0.0059983,-0.0001428289,0
+1479,-0.005882533,-0.001181444,0
+1480,-0.0056071,-0.002135516,0
+1481,-0.005176526,-0.00303374,0
+1482,-0.004579559,-0.00387655,0
+1483,-0.003849254,-0.004602526,0
+1484,-0.003025677,-0.005181243,0
+1485,-0.002112419,-0.005615842,0
+1486,-0.001152477,-0.005888276,0
+1487,-0.0001654924,-0.005997717,0
+1488,0.0008260249,-0.005942868,0
+1489,0.001794916,-0.005725232,0
+1490,0.002719349,-0.005348378,0
+1491,0.003580833,-0.004814316,0
+1492,0.004336478,-0.004146681,0
+1493,0.004976521,-0.003351751,0
+1494,0.005472582,-0.002459848,0
+1495,0.00580954,-0.001499748,0
+1496,0.005979421,-0.0004965166,0
+1497,0.004974967,0.0004997062,0.05
+1498,0.004766671,0.001509584,0.05
+1499,0.004338737,0.002485027,0.05
+1500,0.003711768,0.003350041,0.05
+1501,0.002943709,0.004041606,0.05
+1502,0.002061528,0.004555228,0.05
+1503,0.00104057,0.004890523,0.05
+1504,-0.00005335747,0.004999715,0.05
+1505,-0.001114444,0.004874219,0.05
+1506,-0.002128922,0.004524123,0.05
+1507,-0.003044649,0.00396612,0.05
+1508,-0.003793855,0.003256788,0.05
+1509,-0.004370794,0.002428201,0.05
+1510,-0.004775167,0.001482491,0.05
+1511,-0.004981033,0.0004350947,0.05
+1512,-0.004959594,-0.0006343732,0.05
+1513,-0.004713294,-0.00166879,0.05
+1514,-0.004271109,-0.002599544,0.05
+1515,-0.003669827,-0.003395934,0.05
+1516,-0.002911649,-0.004064763,0.05
+1517,-0.001986236,-0.004588558,0.05
+1518,-0.0009803373,-0.004902952,0.05
+1519,0.00001781337,-0.004999968,0.05
+1520,0.001097304,-0.004878107,0.05
+1521,0.002176931,-0.004501219,0.05
+1522,0.003074063,-0.003943366,0.05
+1523,0.00379592,-0.003254381,0.05
+1524,0.004377258,-0.002416529,0.05
+1525,0.004776511,-0.001478155,0.05
+1526,0.004974981,-0.0004995675,0.05
+1527,0.004974967,0.0004997062,0
+1528,0.004766671,0.001509584,0
+1529,0.004338737,0.002485027,0
+1530,0.003711768,0.003350041,0
+1531,0.002943709,0.004041606,0
+1532,0.002061528,0.004555228,0
+1533,0.00104057,0.004890523,0
+1534,-0.00005335747,0.004999715,0
+1535,-0.001114444,0.004874219,0
+1536,-0.002128922,0.004524123,0
+1537,-0.003044649,0.00396612,0
+1538,-0.003793855,0.003256788,0
+1539,-0.004370794,0.002428201,0
+1540,-0.004775167,0.001482491,0
+1541,-0.004981033,0.0004350947,0
+1542,-0.004959594,-0.0006343732,0
+1543,-0.004713294,-0.00166879,0
+1544,-0.004271109,-0.002599544,0
+1545,-0.003669827,-0.003395934,0
+1546,-0.002911649,-0.004064763,0
+1547,-0.001986236,-0.004588558,0
+1548,-0.0009803373,-0.004902952,0
+1549,0.00001781337,-0.004999968,0
+1550,0.001097304,-0.004878107,0
+1551,0.002176931,-0.004501219,0
+1552,0.003074063,-0.003943366,0
+1553,0.00379592,-0.003254381,0
+1554,0.004377258,-0.002416529,0
+1555,0.004776511,-0.001478155,0
+1556,0.004974981,-0.0004995675,0
+1557,0.005,-1.224647E-018,0.0005890884
+1558,0.005,-1.224647E-018,0.001698279
+1559,0.005,-1.224647E-018,0.00275513
+1560,0.005,-1.224647E-018,0.003926259
+1561,0.005,-1.224647E-018,0.005058963
+1562,0.005,-1.224647E-018,0.006108357
+1563,0.005,-1.224647E-018,0.007212742
+1564,0.005,-1.224647E-018,0.008352902
+1565,0.005,-1.224647E-018,0.009460972
+1566,0.005,-1.224647E-018,0.01051894
+1567,0.005,-1.224647E-018,0.01168895
+1568,0.005,-1.224647E-018,0.01282053
+1569,0.005,-1.224647E-018,0.01386993
+1570,0.005,-1.224647E-018,0.01497656
+1571,0.005,-1.224647E-018,0.01611672
+1572,0.005,-1.224647E-018,0.01722367
+1573,0.005,-1.224647E-018,0.01828276
+1574,0.005,-1.224647E-018,0.01945164
+1575,0.005,-1.224647E-018,0.02058211
+1576,0.005,-1.224647E-018,0.0216315
+1577,0.005,-1.224647E-018,0.02274037
+1578,0.005,-1.224647E-018,0.02388053
+1579,0.005,-1.224647E-018,0.02498636
+1580,0.005,-1.224647E-018,0.02604657
+1581,0.005,-1.224647E-018,0.02721434
+1582,0.005,-1.224647E-018,0.02834368
+1583,0.005,-1.224647E-018,0.02939307
+1584,0.005,-1.224647E-018,0.03050418
+1585,0.005,-1.224647E-018,0.03164434
+1586,0.005,-1.224647E-018,0.03274905
+1587,0.005,-1.224647E-018,0.03381039
+1588,0.005,-1.224647E-018,0.03497703
+1589,0.005,-1.224647E-018,0.03610525
+1590,0.005,-1.224647E-018,0.03715464
+1591,0.005,-1.224647E-018,0.038268
+1592,0.005,-1.224647E-018,0.03940816
+1593,0.005,-1.224647E-018,0.04051174
+1594,0.005,-1.224647E-018,0.04164492
+1595,0.005,-1.224647E-018,0.04275072
+1596,0.005,-1.224647E-018,0.04380011
+1597,0.005,-1.224647E-018,0.04495133
+1598,0.005,-1.224647E-018,0.04609149
+1599,0.005,-1.224647E-018,0.04717614
+1600,0.005,-1.224647E-018,0.04825269
+1601,0.005,-1.224647E-018,0.0493923
+1602,-0.004164202,0.004319655,0.03607786
+1603,-0.00455238,0.003908432,0.0348987
+1604,-0.005050521,0.003239172,0.03635282
+1605,-0.00589796,-0.001101846,0.02734159
+1606,-0.005504227,-0.002388196,0.02798545
+1607,-0.005896706,-0.00110854,0.02867984
+1608,-0.005644181,0.002035491,0.0342849
+1609,-0.005235877,0.002930118,0.03374086
+1610,-0.005571252,0.002227364,0.03285212
+1611,-0.005899465,-0.001093761,0.03014834
+1612,-0.005994868,0.0002481113,0.02950449
+1613,-0.005998361,0.0001402187,0.02430834
+1614,-0.00587996,0.00119418,0.02563007
+1615,-0.005803774,0.001521909,0.02444887
+1616,-0.002488485,0.005459619,0.0391618
+1617,-0.003531085,0.004850922,0.03896118
+1618,-0.003292176,0.005016132,0.04030279
+1619,-0.00585189,-0.00132491,0.03148443
+1620,-0.005403097,-0.002608936,0.03065978
+1621,-0.005681978,0.001927466,0.02143116
+1622,-0.005963227,0.0006632704,0.02174118
+1623,-0.00573954,0.001748624,0.02281712
+1624,-0.005143874,0.003088779,0.02107287
+1625,-0.005624182,0.002090114,0.01999693
+1626,-0.005999972,0.00001843315,0.02676277
+1627,-0.00583347,0.001403789,0.02690329
+1628,-0.005680066,-0.001933093,0.03276585
+1629,-0.005988653,-0.0003688331,0.0322544
+1630,-0.005854762,-0.001312158,0.02606837
+1631,-0.005998173,0.0001480519,0.03346599
+1632,-0.005949326,0.0007781512,0.03218457
+1633,-0.005341985,0.002731885,0.02413885
+1634,-0.005932612,-0.0008967217,0.02352897
+1635,-0.005873017,-0.001227871,0.02471018
+1636,-0.005540602,-0.002302548,0.025289
+1637,-0.005538543,0.002307498,0.01853236
+1638,-0.005901954,0.00108025,0.01889065
+1639,-0.005742308,0.001739511,0.03164053
+1640,-0.00578532,0.00159062,0.03013344
+1641,-0.005789288,0.001576118,0.02866494
+1642,-0.00543193,0.002548359,0.01720211
+1643,-0.004906022,0.00345412,0.01830839
+1644,-0.005751971,0.001707287,0.03535495
+1645,-0.005924636,0.0009479941,0.0344662
+1646,-0.005996752,-0.0001973962,0.03453603
+1647,-0.005368029,0.002680348,0.02753224
+1648,-0.005736537,0.001758449,0.01606249
+1649,-0.005218416,0.002961103,0.01583852
+1650,-0.005986392,-0.0004038673,0.03559452
+1651,-0.005878787,-0.001199943,0.03459431
+1652,-0.005149329,-0.003079678,0.03340509
+1653,-0.005576739,-0.002213591,0.03417506
+1654,-0.00549717,-0.002404396,0.03523355
+1655,-0.005958588,-0.0007037254,0.02215691
+1656,-0.0059777,-0.0005168231,0.02077095
+1657,-0.005999334,-0.00008939028,0.01781766
+1658,-0.005991305,-0.0003228971,0.01928223
+1659,-0.005762718,-0.001670653,0.01969795
+1660,-0.005211133,0.002973902,0.03080098
+1661,-0.0046779,-0.003757293,0.03124571
+1662,-0.004822036,-0.003570429,0.02990961
+1663,-0.004891318,-0.003474912,0.02723567
+1664,-0.00488737,-0.003480461,0.02857392
+1665,-0.003979374,-0.004490499,0.02915984
+1666,-0.005996483,0.0002054007,0.01612862
+1667,-0.005879646,-0.001195725,0.0165202
+1668,-0.005962602,0.0006688636,0.01476503
+1669,-0.004027129,0.004447722,0.01792741
+1670,-0.004218458,0.004266687,0.01925766
+1671,-0.005642319,-0.002040645,0.02255874
+1672,-0.005217657,-0.002962441,0.03596742
+1673,-0.00565678,-0.002000211,0.03638667
+1674,-0.005210983,-0.002974165,0.02030316
+1675,-0.0053046,-0.002803787,0.01881444
+1676,-0.005497413,-0.002403841,0.01560345
+1677,-0.005372702,-0.002670969,0.01729248
+1678,-0.004914652,-0.00344183,0.03728283
+1679,-0.004652647,-0.003788519,0.03612971
+1680,-0.004701403,-0.003727842,0.0148254
+1681,-0.005503476,-0.002389928,0.01405311
+1682,-0.003797482,-0.004645334,0.0365112
+1683,-0.004219106,-0.004266046,0.03519579
+1684,-0.005395788,-0.002624017,0.0383407
+1685,-0.004884554,-0.003484413,0.03850299
+1686,-0.004111375,-0.004369965,0.02645932
+1687,-0.00493014,-0.003419608,0.02587084
+1688,-0.004978782,-0.003348392,0.02451265
+1689,-0.004416024,0.004061863,0.03346591
+1690,-0.003289986,0.005017568,0.02021297
+1691,-0.00431211,0.004172014,0.02059394
+1692,-0.004430337,0.004046247,0.02202818
+1693,-0.004349552,-0.004132965,0.03398869
+1694,-0.004549997,-0.003911205,0.03257948
+1695,-0.003741126,-0.004690839,0.03182931
+1696,-0.004487676,0.003982557,0.03019841
+1697,-0.004383319,0.004097135,0.0317055
+1698,-0.004712689,-0.003713564,0.03959578
+1699,-0.004068332,-0.004410065,0.03853791
+1700,-0.003913607,0.004547931,0.01677793
+1701,-0.003048377,0.00516792,0.01772719
+1702,-0.004360038,0.004121901,0.01569959
+1703,-0.00489679,0.003467196,0.01455997
+1704,-0.005908933,-0.001041396,0.03666456
+1705,-0.005999892,-0.00003603883,0.03660628
+1706,-0.005597873,0.002159586,0.03640059
+1707,-0.005902266,0.001078545,0.03658189
+1708,-0.005983733,0.0004415169,0.03765192
+1709,-0.004597482,-0.003855277,0.01789768
+1710,-0.005035523,-0.00326244,0.02311696
+1711,-0.005138742,-0.003097309,0.02174489
+1712,-0.004404463,-0.004074396,0.02086138
+1713,-0.003431417,-0.004921928,0.03437018
+1714,-0.004233923,-0.00425134,0.0236988
+1715,-0.003824589,0.004623042,0.03767608
+1716,-0.003146337,0.005108871,0.03622196
+1717,-0.005369697,0.002677005,0.03757976
+1718,-0.005768783,-0.00164959,0.03739843
+1719,-0.003485712,0.004883627,0.03286333
+1720,-0.00447792,0.003993523,0.02352617
+1721,-0.004631275,0.003814616,0.02515791
+1722,-0.004500372,0.003968205,0.02853324
+1723,-0.00461604,0.003833037,0.02677159
+1724,-0.0034972,0.004875407,0.02615891
+1725,-0.004485032,0.003985535,0.03881707
+1726,-0.005999819,0.00004665824,0.01345326
+1727,-0.005781058,0.001606041,0.01338713
+1728,-0.004452207,0.00402217,0.01325225
+1729,-0.005284095,0.002842242,0.01339118
+1730,-0.005550452,0.002278701,0.01207941
+1731,-0.003440107,0.004915858,0.01549937
+1732,-0.003458807,0.004902719,0.02304724
+1733,-0.000154123,0.00599802,0.03244677
+1734,0.0001166187,0.005998867,0.03357887
+1735,0.001253537,0.005867593,0.03305906
+1736,-0.002202678,0.005581058,0.0269842
+1737,-0.002224896,0.005572238,0.02537052
+1738,-0.003462116,0.004900383,0.02943775
+1739,-0.002039942,0.005642573,0.01338366
+1740,-0.0008267956,0.005942761,0.01370623
+1741,-0.001622513,0.005776457,0.01225084
+1742,-0.002238445,0.005566809,0.02093338
+1743,-0.002114348,0.005615116,0.0195971
+1744,0.001258208,0.005866593,0.04285674
+1745,0.001145679,0.005889603,0.04186757
+1746,0.0001717246,0.005997542,0.04215227
+1747,-0.002632796,-0.005391511,0.03671898
+1748,-0.003196309,-0.005077756,0.0376529
+1749,0.00597472,0.0005501984,0.0493923
+1750,0.00587322,0.001226901,0.04952757
+1751,0.005746291,0.001726308,0.04952757
+1752,0.005565508,0.002241679,0.049507
+1753,0.005360943,0.002694493,0.049507
+1754,0.005696784,0.001883255,0.04903457
+1755,0.005104371,0.003153632,0.04948468
+1756,0.004825931,0.003565163,0.04948468
+1757,0.005271184,0.002866116,0.04899168
+1758,0.004498332,0.003970517,0.04947966
+1759,0.004154379,0.004329103,0.04947966
+1760,0.004693231,0.003738125,0.04896433
+1761,0.003767758,0.004669476,0.04950761
+1762,0.003345571,0.004980678,0.04950761
+1763,0.003980741,0.004489287,0.04898727
+1764,0.002888013,0.005259219,0.04950531
+1765,0.002423643,0.005488712,0.04950531
+1766,0.003137374,0.00511438,0.04901293
+1767,0.001959376,0.005671053,0.04947423
+1768,0.001483423,0.00581373,0.04947423
+1769,0.002213151,0.005576913,0.04897955
+1770,0.0009679704,0.005921405,0.04948201
+1771,0.0004226466,0.005985096,0.04948201
+1772,0.001232171,0.005872117,0.04895624
+1773,-0.0001001721,0.005999164,0.04949016
+1774,-0.0005962108,0.005970304,0.04949016
+1775,0.0001910465,0.005996958,0.04897217
+1776,-0.001107602,0.005896882,0.04948797
+1777,-0.001591723,0.005785017,0.04948797
+1778,-0.0008460603,0.005940049,0.04897813
+1779,-0.002090849,0.005623909,0.04946093
+1780,-0.00257123,0.005421142,0.04946093
+1781,-0.001859216,0.005704675,0.0489489
+1782,-0.003032659,0.005177159,0.04945466
+1783,-0.003467888,0.0048963,0.04945466
+1784,-0.002821206,0.005295356,0.04891558
+1785,-0.003864166,0.004590013,0.049462
+1786,-0.004230702,0.004254546,0.049462
+1787,-0.003678882,0.004739813,0.04891665
+1788,-0.004575926,0.003880838,0.04950178
+1789,-0.004902747,0.003458768,0.04950178
+1790,-0.004420924,0.004056529,0.04896378
+1791,-0.005179589,0.003028508,0.04951036
+1792,-0.005416382,0.002581241,0.04951036
+1793,-0.005043867,0.003249524,0.04901214
+1794,-0.005614547,0.00211586,0.04948446
+1795,-0.005770365,0.001644046,0.04948446
+1796,-0.005520039,0.002351418,0.04899482
+1797,-0.005887528,0.001156293,0.04949905
+1798,-0.005964175,0.0006546843,0.04949905
+1799,-0.005835445,0.001395556,0.04898351
+1800,-0.005998542,0.000132256,0.04949347
+1801,-0.005985518,-0.0004166201,0.04949347
+1802,-0.005987783,0.0003826982,0.04899252
+1803,-0.005929878,-0.0009146273,0.04946334
+1804,-0.005833867,-0.001402141,0.04946334
+1805,-0.005965684,-0.0006407927,0.0489568
+1806,-0.005694223,-0.001890986,0.04946598
+1807,-0.005518234,-0.002355652,0.04946598
+1808,-0.005774057,-0.001631033,0.04892932
+1809,-0.005298197,-0.002815867,0.04947931
+1810,-0.005045378,-0.003247177,0.04947931
+1811,-0.00541539,-0.002583322,0.04894529
+1812,-0.004747163,-0.003669393,0.04948295
+1813,-0.004402318,-0.004076714,0.04948295
+1814,-0.004896035,-0.003468262,0.04896226
+1815,-0.004036734,-0.004439007,0.04947276
+1816,-0.0036556,-0.004757792,0.04947276
+1817,-0.004230242,-0.004255003,0.04895571
+1818,-0.003242578,-0.005048335,0.04946928
+1819,-0.002801721,-0.005305691,0.04946928
+1820,-0.003449409,-0.004909336,0.04894204
+1821,-0.002339755,-0.005524993,0.0494687
+1822,-0.00187001,-0.005701146,0.0494687
+1823,-0.002572131,-0.005420714,0.04893798
+1824,-0.001380698,-0.005838979,0.0494657
+1825,-0.0008928353,-0.005933199,0.0494657
+1826,-0.001617927,-0.005777743,0.04893439
+1827,-0.0004018144,-0.00598653,0.04947816
+1828,0.00009490042,-0.005999249,0.04947816
+1829,-0.0006344614,-0.005966361,0.04894385
+1830,0.0006058554,-0.005969333,0.04947461
+1831,0.001097692,-0.005898735,0.04947461
+1832,0.0003701487,-0.005988572,0.04895277
+1833,0.001581052,-0.005787942,0.04946064
+1834,0.002054536,-0.005637276,0.04946064
+1835,0.001366313,-0.005842362,0.04893525
+1836,0.002499949,-0.00545438,0.04950603
+1837,0.002947283,-0.005226234,0.04950603
+1838,0.002295988,-0.005543324,0.04896667
+1839,0.003377276,-0.004959235,0.04953736
+1840,0.003787951,-0.004653109,0.04953736
+1841,0.003173548,-0.005092013,0.04904339
+1842,0.004164879,-0.004319003,0.04952408
+1843,0.00450796,-0.003959583,0.04952408
+1844,0.003981902,-0.004488258,0.04906144
+1845,0.004807643,-0.003589787,0.04955572
+1846,0.005102776,-0.003156213,0.04955572
+1847,0.004658697,-0.003781077,0.0490798
+1848,0.005347523,-0.002721028,0.04955958
+1849,0.00555433,-0.002269233,0.04955958
+1850,0.005209315,-0.002977086,0.0491153
+1851,0.005709876,-0.001843182,0.04956744
+1852,0.005848342,-0.001340482,0.04956744
+1853,0.005614651,-0.002115583,0.04912703
+1854,0.005934921,-0.0008813109,0.04955701
+1855,0.005987535,-0.0003865543,0.04955701
+1856,0.005987535,-0.0003865543,0.04894931
+1857,0.005872112,-0.001232195,0.04912445
+1858,0.005979421,-0.0004965166,0.0005890884
+1859,0.005987725,-0.0003835941,0.002002263
+1860,0.005987725,-0.0003835941,0.00148216
+1861,0.005977439,-0.0005198352,0.004235437
+1862,0.005977439,-0.0005198352,0.003601056
+1863,0.005975702,-0.0005394344,0.006407228
+1864,0.005975702,-0.0005394344,0.005856157
+1865,0.005975241,-0.0005445086,0.008669683
+1866,0.005975241,-0.0005445086,0.008082837
+1867,0.005982495,-0.0004579847,0.01080195
+1868,0.005982495,-0.0004579847,0.0102652
+1869,0.005980722,-0.0004805873,0.01304108
+1870,0.005980722,-0.0004805873,0.01254276
+1871,0.005965409,-0.0006433447,0.01525936
+1872,0.005965409,-0.0006433447,0.01470381
+1873,0.005971941,-0.0005795917,0.01754448
+1874,0.005971941,-0.0005795917,0.01702214
+1875,0.005976826,-0.0005268255,0.01973734
+1876,0.005976826,-0.0005268255,0.0191052
+1877,0.005965985,-0.0006379826,0.02181757
+1878,0.005965985,-0.0006379826,0.0212665
+1879,0.005965364,-0.0006437653,0.02414914
+1880,0.005965364,-0.0006437653,0.02356678
+1881,0.005982395,-0.0004592994,0.02632482
+1882,0.005982395,-0.0004592994,0.02578807
+1883,0.005982046,-0.0004638194,0.02856448
+1884,0.005982046,-0.0004638194,0.02806616
+1885,0.005966539,-0.0006327832,0.03076748
+1886,0.005966539,-0.0006327832,0.03020744
+1887,0.005971371,-0.000585435,0.03303521
+1888,0.005971371,-0.000585435,0.03251063
+1889,0.005963636,-0.0006595776,0.03528306
+1890,0.005963636,-0.0006595776,0.03465317
+1891,0.005971721,-0.0005818516,0.0374164
+1892,0.005971721,-0.0005818516,0.03686533
+1893,0.005967787,-0.0006209026,0.03973831
+1894,0.005967787,-0.0006209026,0.03916043
+1895,0.005971235,-0.0005868136,0.04194205
+1896,0.005971235,-0.0005868136,0.04133458
+1897,0.005970336,-0.0005958961,0.04405074
+1898,0.005970336,-0.0005958961,0.04349966
+1899,0.005982596,-0.000456661,0.04633155
+1900,0.005982596,-0.000456661,0.04579154
+1901,0.005992569,-0.0002985177,0.04848627
+1902,0.005992569,-0.0002985177,0.04795436
+1903,0.005960888,-0.0006839731,0.04865098
+1904,0.005974874,0.0005485208,0.0005890884
+1905,0.005754038,0.001700309,0.0004679643
+1906,0.005878721,0.001200268,0.0004679643
+1907,0.004817307,0.003576808,0.0005595919
+1908,0.005096775,0.003165895,0.0005595919
+1909,0.003275217,0.005027221,0.0005994213
+1910,0.003701789,0.004721945,0.0005994213
+1911,0.001450785,0.005821961,0.0004170435
+1912,0.001927592,0.005681935,0.0004170435
+1913,-0.0005721666,0.005972656,0.0005913325
+1914,-0.00007595028,0.005999519,0.0005913325
+1915,-0.002574555,0.005419563,0.0006220414
+1916,-0.002094237,0.005622648,0.0006220414
+1917,-0.004211126,0.004273923,0.0004298954
+1918,-0.003843004,0.004607746,0.0004298954
+1919,-0.00542456,0.002564009,0.0007012171
+1920,-0.005189157,0.003012083,0.0007012171
+1921,-0.005966549,0.0006326849,0.0006581677
+1922,-0.00589174,0.001134637,0.0006581677
+1923,-0.005827547,-0.001428178,0.0004565747
+1924,-0.005925745,-0.0009410343,0.0004565747
+1925,-0.005100846,-0.003159331,0.0006346146
+1926,-0.005346188,-0.00272365,0.0006346146
+1927,-0.003693354,-0.004728545,0.0006206733
+1928,-0.004071987,-0.004406691,0.0006206733
+1929,-0.001861075,-0.005704069,0.0006038656
+1930,-0.002331176,-0.005528618,0.0006038656
+1931,0.00006504326,-0.005999647,0.0006142506
+1932,-0.0004316673,-0.005984452,0.0006142506
+1933,0.002075298,-0.005629666,0.0006491944
+1934,0.001602309,-0.005782093,0.0006491944
+1935,0.003849573,-0.004602259,0.0005316632
+1936,0.003442957,-0.004913863,0.0005316632
+1937,0.005113208,-0.003139283,0.0005199753
+1938,0.004819476,-0.003573885,0.0005199753
+1939,0.005886125,-0.001163415,0.0004568661
+1940,0.005762871,-0.001670127,0.0004568661
+1941,0.005988277,0.0003748906,0.001471571
+1942,0.005988277,0.0003748906,0.001991674
+1943,0.005984258,0.0004343411,0.002482379
+1944,0.005984258,0.0004343411,0.003019127
+1945,0.005945427,0.0008073995,0.00225567
+1946,0.005980401,0.0004845673,0.003565147
+1947,0.005980401,0.0004845673,0.004199527
+1948,0.005929633,0.0009162183,0.003292395
+1949,0.005979218,0.0004989512,0.004766059
+1950,0.005979218,0.0004989512,0.005264382
+1951,0.005919391,0.0009802102,0.004404947
+1952,0.005976998,0.0005248753,0.005820381
+1953,0.005976998,0.0005248753,0.006371453
+1954,0.005912648,0.001020096,0.005527478
+1955,0.00597649,0.0005306287,0.006931362
+1956,0.00597649,0.0005306287,0.007484676
+1957,0.005907159,0.001051413,0.006643386
+1958,0.005976771,0.0005274589,0.00805092
+1959,0.005976771,0.0005274589,0.008637766
+1960,0.005906704,0.001053967,0.00776954
+1961,0.005978853,0.0005033102,0.009181628
+1962,0.005978853,0.0005033102,0.009702851
+1963,0.005911459,0.001026961,0.008879645
+1964,0.005979025,0.0005012582,0.01025689
+1965,0.005979025,0.0005012582,0.01079364
+1966,0.005915904,0.001001042,0.009977543
+1967,0.005977485,0.0005192956,0.01136369
+1968,0.005977485,0.0005192956,0.01199695
+1969,0.005913206,0.001016857,0.01110163
+1970,0.00597636,0.0005320937,0.01255505
+1971,0.00597636,0.0005320937,0.01305337
+1972,0.005907882,0.001047347,0.01222979
+1973,0.005975082,0.0005462514,0.01359404
+1974,0.005975082,0.0005462514,0.01414511
+1975,0.005903098,0.001073983,0.01332856
+1976,0.005975633,0.0005401978,0.01469986
+1977,0.005975633,0.0005401978,0.01525541
+1978,0.005901636,0.001081987,0.01442397
+1979,0.005976474,0.0005308044,0.01581865
+1980,0.005976474,0.0005308044,0.01640325
+1981,0.005904413,0.001066728,0.01554195
+1982,0.005978017,0.0005131348,0.0169489
+1983,0.005978017,0.0005131348,0.01747125
+1984,0.005909182,0.001039983,0.01665084
+1985,0.005977594,0.0005180487,0.0180282
+1986,0.005977594,0.0005180487,0.01856494
+1987,0.005911388,0.001027369,0.01775343
+1988,0.005976651,0.00052881,0.01912496
+1989,0.005976651,0.00052881,0.0197571
+1990,0.005908674,0.001042868,0.0188704
+1991,0.005977576,0.0005182549,0.02031828
+1992,0.005977576,0.0005182549,0.0208166
+1993,0.005908638,0.001043072,0.01999159
+1994,0.005977159,0.0005230412,0.0213661
+1995,0.005977159,0.0005230412,0.02191717
+1996,0.005909642,0.001037368,0.02110227
+1997,0.005976594,0.0005294536,0.02247146
+1998,0.005976594,0.0005294536,0.02302926
+1999,0.005907688,0.001048439,0.02220606
+2000,0.005976221,0.0005336474,0.02358985
+2001,0.005976221,0.0005336474,0.02417221
+2002,0.005905818,0.001058921,0.02332094
+2003,0.005977991,0.0005134388,0.02470895
+2004,0.005977991,0.0005134388,0.02523242
+2005,0.005908634,0.001043094,0.02441827
+2006,0.005978447,0.0005081046,0.02578736
+2007,0.005978447,0.0005081046,0.02632411
+2008,0.005913037,0.001017835,0.02550995
+2009,0.005977824,0.0005153814,0.02688843
+2010,0.005977824,0.0005153814,0.02751945
+2011,0.005912706,0.001019757,0.02662922
+2012,0.005978188,0.0005111479,0.02807619
+2013,0.005978188,0.0005111479,0.02857451
+2014,0.005912186,0.001022766,0.02775028
+2015,0.005977851,0.0005150694,0.02912022
+2016,0.005977851,0.0005150694,0.02967129
+2017,0.00591224,0.001022458,0.02885273
+2018,0.005977599,0.0005179826,0.03022636
+2019,0.005977599,0.0005179826,0.0307864
+2020,0.005911067,0.001029217,0.02995351
+2021,0.005977292,0.0005215145,0.03134892
+2022,0.005977292,0.0005215145,0.03192904
+2023,0.005909954,0.00103559,0.0310711
+2024,0.005977828,0.0005153339,0.03247386
+2025,0.005977828,0.0005153339,0.03299845
+2026,0.005910412,0.001032971,0.03217843
+2027,0.00597643,0.0005313005,0.03355683
+2028,0.00597643,0.0005313005,0.03409358
+2029,0.005908713,0.001042647,0.03328164
+2030,0.005975086,0.0005462131,0.03465805
+2031,0.005975086,0.0005462131,0.03528794
+2032,0.005903247,0.001073162,0.03440449
+2033,0.005976903,0.0005259542,0.03583279
+2034,0.005976903,0.0005259542,0.03633111
+2035,0.005904204,0.001067881,0.0355138
+2036,0.005977088,0.0005238471,0.0368873
+2037,0.005977088,0.0005238471,0.03743837
+2038,0.00590816,0.001045776,0.03661483
+2039,0.005977825,0.0005153748,0.03799775
+2040,0.005977825,0.0005153748,0.03856003
+2041,0.005910001,0.001035318,0.0377304
+2042,0.005977823,0.0005153907,0.03912619
+2043,0.005977823,0.0005153907,0.03970407
+2044,0.00591146,0.001026956,0.03885594
+2045,0.005979012,0.0005014171,0.04025281
+2046,0.005979012,0.0005014171,0.04077852
+2047,0.005913842,0.001013152,0.03997084
+2048,0.005977398,0.0005202979,0.04135098
+2049,0.005977398,0.0005202979,0.04195845
+2050,0.005913008,0.001018006,0.04109205
+2051,0.00597763,0.0005176312,0.04251046
+2052,0.00597763,0.0005176312,0.04300879
+2053,0.005910225,0.001034039,0.04221653
+2054,0.005976515,0.0005303447,0.04357252
+2055,0.005976515,0.0005303447,0.04412359
+2056,0.005908479,0.001043973,0.04333227
+2057,0.005978202,0.000510981,0.04469525
+2058,0.005978202,0.000510981,0.0452954
+2059,0.005909636,0.001037399,0.04446766
+2060,0.005980414,0.0004844045,0.04586056
+2061,0.005980414,0.0004844045,0.04640057
+2062,0.005917434,0.0009919576,0.04560447
+2063,0.005983211,0.0004485431,0.04693605
+2064,0.005983211,0.0004485431,0.04748069
+2065,0.005927467,0.0009301279,0.04670511
+2066,0.005987932,0.0003803512,0.0479611
+2067,0.005987932,0.0003803512,0.04849301
+2068,0.005942743,0.0008269279,0.047721
+2069,0.005962212,-0.0006723314,0.001045954
+2070,0.005960981,0.0006831585,0.04891986
+2071,0.005963832,0.0006578085,0.001057053
+2072,0.005981156,-0.000475159,0.003045671
+2073,0.005981156,-0.000475159,0.002508923
+2074,0.005976324,-0.0005324969,0.005289752
+2075,0.005976324,-0.0005324969,0.004791428
+2076,0.005974887,-0.0005483865,0.007507099
+2077,0.005974887,-0.0005483865,0.006953786
+2078,0.005974686,-0.000550575,0.009745105
+2079,0.005974686,-0.000550575,0.009223881
+2080,0.005963772,-0.00065835,0.01198092
+2081,0.005963772,-0.00065835,0.01134766
+2082,0.005970084,-0.0005984076,0.01411924
+2083,0.005970084,-0.0005984076,0.01356817
+2084,0.005965988,-0.0006379592,0.01644256
+2085,0.005965988,-0.0006379592,0.01585796
+2086,0.005985812,-0.00041238,0.01858137
+2087,0.005985812,-0.00041238,0.01804462
+2088,0.005980749,-0.0004802493,0.0207655
+2089,0.005980749,-0.0004802493,0.02026717
+2090,0.005963453,-0.0006612283,0.02296585
+2091,0.005963453,-0.0006612283,0.02240805
+2092,0.005971888,-0.0005801353,0.02525591
+2093,0.005971888,-0.0005801353,0.02473244
+2094,0.005965625,-0.0006413427,0.02750785
+2095,0.005965625,-0.0006413427,0.02687683
+2096,0.005971961,-0.000579385,0.029637
+2097,0.005971961,-0.000579385,0.02908593
+2098,0.005966468,-0.0006334551,0.03193521
+2099,0.005966468,-0.0006334551,0.03135509
+2100,0.005981668,-0.0004686637,0.03409868
+2101,0.005981668,-0.0004686637,0.03356193
+2102,0.005981342,-0.0004728134,0.03633667
+2103,0.005981342,-0.0004728134,0.03583835
+2104,0.005966882,-0.0006295424,0.03856199
+2105,0.005966882,-0.0006295424,0.03799971
+2106,0.005979892,-0.000490806,0.04079609
+2107,0.005979892,-0.000490806,0.04027039
+2108,0.005980406,-0.0004845017,0.04297571
+2109,0.005980406,-0.0004845017,0.04247739
+2110,0.00597377,-0.0005604259,0.04523661
+2111,0.00597377,-0.0005604259,0.04463646
+2112,0.00596755,-0.0006231737,0.04742332
+2113,0.00596755,-0.0006231737,0.04687867
+2114,0.005907716,-0.001048278,0.004466226
+2115,0.005571346,0.002227129,0.0005038179
+2116,0.00570908,0.001845646,0.0009717822
+2117,0.005367936,0.002680535,0.0005038179
+2118,0.005270266,0.002867804,0.00106341
+2119,0.004118611,0.004363146,0.0005896428
+2120,0.004465547,0.004007355,0.0005896428
+2121,0.00235341,0.00551919,0.0005525011
+2122,0.002820729,0.00529561,0.0005525011
+2123,0.0004493574,0.00598315,0.0005429984
+2124,0.0009944559,0.005917014,0.0005429984
+2125,-0.00159293,0.005784685,0.000619793
+2126,-0.001108767,0.005896663,0.000619793
+2127,-0.003465304,0.004898129,0.000526336
+2128,-0.003029871,0.005178792,0.000526336
+2129,-0.004878164,0.003493353,0.0007396674
+2130,-0.004548324,0.003913151,0.0007396674
+2131,-0.005031981,0.0032679,0.001440884
+2132,-0.005773928,0.001631488,0.0005526214
+2133,-0.005619114,0.0021037,0.0005526214
+2134,-0.005981981,-0.0004646571,0.0006284142
+2135,-0.00599941,0.00008416217,0.0006284142
+2136,-0.005536564,-0.002312241,0.0004544932
+2137,-0.005708919,-0.001846144,0.0004544932
+2138,-0.004455786,-0.004018205,0.0006619292
+2139,-0.004795259,-0.003606313,0.0006619292
+2140,-0.002802913,-0.005305062,0.0006064186
+2141,-0.003243747,-0.005047584,0.0006064186
+2142,-0.0009100394,-0.005930584,0.0004951945
+2143,-0.00139769,-0.005834935,0.0004951945
+2144,0.001084626,-0.005901151,0.0006501356
+2145,0.0005925689,-0.005970667,0.0006501356
+2146,0.003000493,-0.005195868,0.000592863
+2147,0.002555452,-0.005428597,0.000592863
+2148,0.00452549,-0.003939536,0.0004233345
+2149,0.004183961,-0.00430052,0.0004233345
+2150,0.005582206,-0.002199768,0.0005048662
+2151,0.005381023,-0.002654166,0.0005048662
+2152,0.005905685,0.001059662,0.04862828
+2153,0.005907031,-0.001052134,0.001349938
+2154,0.005938542,-0.0008565763,0.002292804
+2155,0.005915229,-0.001005021,0.01002811
+2156,0.005900465,-0.001088353,0.00782388
+2157,0.005904247,-0.001067646,0.005588622
+2158,0.005900066,-0.001090514,0.008953815
+2159,0.005896121,-0.001111649,0.01109392
+2160,0.005902971,-0.001074676,0.01329039
+2161,0.005863188,-0.001273979,0.01558521
+2162,0.005917983,-0.0009886726,0.0178431
+2163,0.005915482,-0.00100353,0.01992073
+2164,0.005859337,-0.001291576,0.02204305
+2165,0.005875169,-0.001217535,0.0244187
+2166,0.005899025,-0.001096129,0.02661833
+2167,0.005909302,-0.001039303,0.02880841
+2168,0.005866387,-0.001259169,0.03105835
+2169,0.005907397,-0.001050074,0.03332351
+2170,0.005893115,-0.001127474,0.03551449
+2171,0.005877708,-0.001205215,0.03771039
+2172,0.005896996,-0.001106993,0.04002266
+2173,0.00590435,-0.001067076,0.04216705
+2174,0.005888576,-0.001150946,0.04433601
+2175,0.005902811,-0.001075557,0.04657872
+2176,0.002996801,0.005197998,0.001151922
+2177,0.0012231,0.005874013,0.0009600419
+2178,-0.0008254822,0.005942944,0.001211126
+2179,-0.002823306,0.005294237,0.001148377
+2180,-0.004374413,0.004106642,0.001169563
+2181,-0.00553307,0.002320589,0.001253838
+2182,-0.005991911,0.0003114429,0.001286582
+2183,-0.00577933,-0.00161225,0.0009110679
+2184,-0.004999299,-0.003317681,0.001296544
+2185,-0.003489213,-0.004881126,0.001227092
+2186,-0.001625595,-0.00577559,0.00109906
+2187,0.0003268474,-0.005991091,0.001264386
+2188,0.002372347,-0.005511077,0.001242057
+2189,0.004060404,-0.004417366,0.0009549977
+2190,0.005255182,-0.002895352,0.001024842
+2191,0.005891878,-0.00113392,0.01220147
+2192,0.005871502,-0.001235095,0.01440205
+2193,0.005876461,-0.001211282,0.01676338
+2194,0.005926484,-0.000936367,0.01886707
+2195,0.005895778,-0.001113462,0.02095156
+2196,0.005858082,-0.001297255,0.02323447
+2197,0.005909955,-0.00103558,0.02553416
+2198,0.005898196,-0.001100586,0.02772865
+2199,0.005877552,-0.00120598,0.0299003
+2200,0.00587619,-0.001212596,0.03222138
+2201,0.005893896,-0.001123386,0.03440471
+2202,0.005907299,-0.001050627,0.03659843
+2203,0.005869699,-0.001243638,0.03889214
+2204,0.005903222,-0.0010733,0.04109322
+2205,0.00590272,-0.001076056,0.04322634
+2206,0.005913788,-0.001013465,0.04547666
+2207,0.0002396977,0.00599521,0.001134331
+2208,-0.001865802,0.005702524,0.001241834
+2209,-0.00365595,0.004757523,0.0009562313
+2210,-0.005957099,-0.0007162164,0.001084989
+2211,-0.005478407,-0.002446845,0.001089108
+2212,-0.004319068,-0.004164812,0.001282603
+2213,-0.002564682,-0.005424243,0.001210284
+2214,-0.0006815331,-0.005961167,0.001109445
+2215,0.001374556,-0.005840428,0.00129933
+2216,0.003291939,-0.005016287,0.001124526
+2217,0.004687321,-0.003745534,0.0009433098
+2218,0.005699394,-0.001875342,0.0009617323
+2219,0.005917498,-0.0009915748,0.003354849
+2220,0.005901387,-0.001083342,0.006701585
+2221,0.004651335,0.00379013,0.001149235
+2222,0.002107975,0.005617512,0.0009695446
+2223,0.003877575,0.004578691,0.001189064
+2224,-0.005843803,0.001360136,0.001210789
+2225,0.005911078,0.001029154,0.001350447
+2226,0.005429233,0.002554099,0.04846749
+2227,0.005184695,0.003019758,0.04844516
+2228,0.004878685,0.003492626,0.04840495
+2229,0.004557182,0.003902831,0.04839993
+2230,0.005073907,0.003202415,0.04788076
+2231,0.004177437,0.004306858,0.04839723
+2232,0.003792638,0.00464929,0.04842519
+2233,0.004392723,0.004087051,0.04783784
+2234,0.003386629,0.004952852,0.04853073
+2235,0.002931389,0.005235165,0.04852843
+2236,0.00360464,0.004796517,0.04794068
+2237,0.002500089,0.005454315,0.04840029
+2238,0.002038415,0.005643125,0.04836921
+2239,0.002766947,0.005323909,0.04791809
+2240,0.001527755,0.005802238,0.04834965
+2241,0.001013139,0.005913844,0.04835743
+2242,0.001827334,0.005714967,0.0477704
+2243,0.000479182,0.005980835,0.0484066
+2244,-0.00004348037,0.005999842,0.04841475
+2245,0.000781232,0.005948922,0.04780002
+2246,-0.0005913131,0.005970791,0.04842068
+2247,-0.001102764,0.005897789,0.0484185
+2248,-0.0003035308,0.005992318,0.04785512
+2249,-0.001616795,0.00577806,0.04837139
+2250,-0.002115217,0.005614789,0.04834434
+2251,-0.001368269,0.005841904,0.04781393
+2252,-0.002603586,0.005405677,0.04831198
+2253,-0.003063549,0.005158941,0.04830571
+2254,-0.00237312,0.005510744,0.04773447
+2255,-0.00351103,0.004865457,0.04829222
+2256,-0.003904585,0.00455568,0.04829956
+2257,-0.003310317,0.005004178,0.04768861
+2258,-0.004287839,0.004196956,0.04833783
+2259,-0.004627979,0.003818614,0.04837762
+2260,-0.004138582,0.004344208,0.0477134
+2261,-0.004912561,0.003444815,0.04850964
+2262,-0.005188178,0.003013769,0.04851822
+2263,-0.004798942,0.00360141,0.0478837
+2264,-0.005414991,0.002584159,0.04843721
+2265,-0.005613406,0.002118884,0.0484113
+2266,-0.005309491,0.002794514,0.04793471
+2267,-0.005777868,0.001617481,0.04839499
+2268,-0.005892785,0.001129194,0.04840958
+2269,-0.005703814,0.001861857,0.04783738
+2270,-0.005964643,0.0006504091,0.04849567
+2271,-0.005998635,0.0001279563,0.04849008
+2272,-0.00593544,0.0008778142,0.04790714
+2273,-0.005989877,-0.0003483886,0.04835572
+2274,-0.005939915,-0.0008469975,0.04832559
+2275,-0.005999469,-0.0000798507,0.04785887
+2276,-0.005844694,-0.001356299,0.04834339
+2277,-0.005708892,-0.001846225,0.04834604
+2278,-0.00590401,-0.001068954,0.04774231
+2279,-0.005520717,-0.002349826,0.04836987
+2280,-0.005301167,-0.002810273,0.0483832
+2281,-0.005625612,-0.002086262,0.04778394
+2282,-0.005045799,-0.003246523,0.0484077
+2283,-0.004747638,-0.003668778,0.04841134
+2284,-0.00517977,-0.003028198,0.04783228
+2285,-0.004406801,-0.004071867,0.04840079
+2286,-0.004041616,-0.004434562,0.0483906
+2287,-0.004583963,-0.003871341,0.04784623
+2288,-0.003653589,-0.004759337,0.04835003
+2289,-0.003240443,-0.005049706,0.04834656
+2290,-0.003852044,-0.004600191,0.04779512
+2291,-0.002798684,-0.005307294,0.04837214
+2292,-0.002336593,-0.005526331,0.04837155
+2293,-0.003020245,-0.005184411,0.04778013
+2294,-0.00183411,-0.005712796,0.04836682
+2295,-0.001343941,-0.005847548,0.04836382
+2296,-0.002073653,-0.005630272,0.04780098
+2297,-0.0008378182,-0.005941217,0.04832626
+2298,-0.0003463241,-0.005989997,0.04833872
+2299,-0.001060703,-0.005905498,0.04775868
+2300,0.0001316227,-0.005998556,0.04843793
+2301,0.000642385,-0.005965513,0.04843438
+2302,-0.0000732801,-0.005999552,0.04782033
+2303,0.001132515,-0.005892148,0.04830843
+2304,0.001615212,-0.005778502,0.04829445
+2305,0.0008972209,-0.005932537,0.04779358
+2306,0.002123028,-0.00561184,0.04831075
+2307,0.002566181,-0.005423534,0.04835613
+2308,0.001897812,-0.005691951,0.04768392
+2309,0.002985112,-0.00520472,0.04853431
+2310,0.003413156,-0.004934609,0.04856564
+2311,0.002822319,-0.005294763,0.04787839
+2312,0.003801364,-0.004642158,0.04851732
+2313,0.004177326,-0.004306965,0.04850404
+2314,0.003628968,-0.004778137,0.04800824
+2315,0.004532826,-0.003931093,0.04851893
+2316,0.004830172,-0.003559415,0.04855056
+2317,0.004373883,-0.004107207,0.04797481
+2318,0.005084686,-0.003185273,0.04866347
+2319,0.005331913,-0.002751492,0.04866734
+2320,0.004978031,-0.003349508,0.0481026
+2321,0.005527644,-0.002333486,0.04858499
+2322,0.005688119,-0.001909267,0.04859285
+2323,0.005428777,-0.00255507,0.04813316
+2324,0.005805563,-0.001515072,0.0487379
+2325,0.005905857,-0.001058701,0.04872747
+2326,0.005920779,-0.0009717921,0.04826443
+2327,0.005741888,-0.001740899,0.04819587
+2328,0.004499737,0.003968925,0.001765686
+2329,0.004847793,0.003535379,0.001735636
+2330,0.00579934,-0.001538719,0.01047579
+2331,0.005774816,-0.001628344,0.009955691
+2332,0.005729263,-0.001782007,0.00698266
+2333,0.005731926,-0.001773421,0.006436102
+2334,0.005734554,-0.001764905,0.009281832
+2335,0.005736343,-0.001759082,0.008727634
+2336,0.005550319,-0.002279027,0.00972951
+2337,0.005778452,-0.001615392,0.005872562
+2338,0.005780324,-0.001608683,0.005306157
+2339,0.00554352,-0.002295514,0.006153637
+2340,0.005744477,-0.001732335,0.0110215
+2341,0.005768727,-0.001649784,0.008131755
+2342,0.005767655,-0.001653528,0.007556018
+2343,0.005531723,-0.002323798,0.007290535
+2344,0.005539477,-0.002305255,0.008459772
+2345,0.005747395,-0.001722628,0.01330778
+2346,0.005780241,-0.00160898,0.0127807
+2347,0.005633991,-0.002063528,0.01591729
+2348,0.005632125,-0.002068614,0.0153187
+2349,0.005694824,-0.001889176,0.01723587
+2350,0.005676078,-0.001944771,0.0166563
+2351,0.005820278,-0.00145752,0.0184172
+2352,0.005777247,-0.001619695,0.01791706
+2353,0.005526008,-0.002337357,0.01780998
+2354,0.005791327,-0.001568608,0.01894103
+2355,0.005758824,-0.001684028,0.02027194
+2356,0.00574553,-0.001728839,0.01974211
+2357,0.005712355,-0.001835483,0.02077294
+2358,0.005635758,-0.002058697,0.02350041
+2359,0.005629706,-0.002075189,0.02289948
+2360,0.005698393,-0.001878382,0.02479046
+2361,0.005678045,-0.001939023,0.02420716
+2362,0.005799059,-0.001539777,0.0260066
+2363,0.005766749,-0.001656686,0.02547443
+2364,0.005515831,-0.002361273,0.0252629
+2365,0.005749457,-0.001715733,0.02655861
+2366,0.005797248,-0.001546581,0.02831189
+2367,0.00574874,-0.001718136,0.02775358
+2368,0.005766264,-0.001658372,0.02883334
+2369,0.005658016,-0.001996712,0.03133524
+2370,0.005658241,-0.001996075,0.03074763
+2371,0.0056951,-0.001888344,0.03260329
+2372,0.005679724,-0.001934099,0.03202788
+2373,0.005789943,-0.00157371,0.03380808
+2374,0.005758093,-0.001686525,0.03328136
+2375,0.005503593,-0.002389658,0.03308786
+2376,0.005736695,-0.001757933,0.03436257
+2377,0.005788757,-0.001578067,0.03611187
+2378,0.005736592,-0.00175827,0.03555659
+2379,0.005759005,-0.001683408,0.03664053
+2380,0.005676277,-0.00194419,0.03926016
+2381,0.005673456,-0.001952407,0.03866172
+2382,0.005747307,-0.001722924,0.04062589
+2383,0.005708427,-0.001847664,0.04009381
+2384,0.005718885,-0.001815036,0.04116438
+2385,0.005755898,-0.001694,0.04265071
+2386,0.005726054,-0.001792291,0.04211537
+2387,0.005723321,-0.001800999,0.04317466
+2388,0.005798974,-0.001540097,0.04591424
+2389,0.005771371,-0.001640512,0.04535931
+2390,0.005753812,-0.001701073,0.04646137
+2391,0.00009030468,0.00599932,0.001847777
+2392,0.0006149571,0.005968402,0.001799443
+2393,0.002612187,0.005401526,0.001815536
+2394,0.00307679,0.005151054,0.001862456
+2395,0.005929155,-0.0009193052,0.0476569
+2396,0.005755305,-0.001696015,0.004735323
+2397,0.005758885,-0.001683818,0.004179331
+2398,0.00557137,-0.002227068,0.005019263
+2399,0.001651462,0.005768247,0.001441562
+2400,0.002084631,0.005626217,0.00157702
+2401,0.002171348,0.005593322,0.002287553
+2402,0.001198698,0.005879041,0.001567517
+2403,0.005180144,0.003027558,0.001644983
+2404,0.005438143,0.002535075,0.001589209
+2405,0.00505793,0.003227591,0.002261435
+2406,-0.005852511,0.001322164,0.002030409
+2407,-0.005718896,0.001815,0.001924863
+2408,0.003612562,0.004790553,0.001875046
+2409,0.004036041,0.004439637,0.001865267
+2410,0.004268196,0.004216931,0.002451668
+2411,0.003255859,0.00503978,0.002538659
+2412,-0.003167344,0.005095874,0.001778933
+2413,-0.002718633,0.005348741,0.001874639
+2414,-0.005844367,-0.00135771,0.001621375
+2415,-0.005934148,-0.0008865021,0.001793215
+2416,-0.005548021,0.002284614,0.002073459
+2417,-0.005999892,-0.00003602378,0.00199626
+2418,-0.005978025,0.0005130471,0.002026013
+2419,-0.005919248,0.0009810732,0.002740087
+2420,-0.005960636,-0.0006861637,0.002532646
+2421,0.005813194,0.001485522,0.001462562
+2422,0.005876971,0.001208804,0.00187708
+2423,0.005650186,0.002018762,0.001498415
+2424,-0.004957129,-0.003380366,0.00205872
+2425,-0.005241687,-0.002919712,0.002031406
+2426,-0.003253369,-0.005041388,0.001840691
+2427,-0.003702367,-0.004721491,0.001854945
+2428,-0.0006981088,-0.005959249,0.001827478
+2429,-0.001173603,-0.005884102,0.001708422
+2430,0.002745191,-0.00533516,0.001943797
+2431,0.002272421,-0.005553026,0.002000129
+2432,0.004412663,-0.004065514,0.001503783
+2433,0.00409526,-0.004385071,0.001612112
+2434,0.004716837,-0.003708294,0.001600424
+2435,0.005368005,-0.002680395,0.001601699
+2436,0.005097827,-0.0031642,0.001616808
+2437,0.005788323,-0.001579659,0.001457708
+2438,0.005615976,-0.002112064,0.001505708
+2439,0.005498788,-0.002400694,0.002097675
+2440,0.00585786,-0.001298261,0.001893914
+2441,0.0057298,-0.001780277,0.01221886
+2442,0.005873671,0.001224739,0.04812826
+2443,0.005804098,0.001520675,0.04855512
+2444,0.005641774,0.002042154,0.04853455
+2445,0.005859338,0.001291574,0.04764784
+2446,0.005837311,-0.001387732,0.002400574
+2447,0.005842267,0.001366716,0.002925287
+2448,0.005830587,0.001415717,0.003471307
+2449,0.005811399,0.001492528,0.004040195
+2450,0.005807792,0.001506502,0.004606726
+2451,0.005680335,0.001932304,0.003673087
+2452,0.005788782,0.001577975,0.005201683
+2453,0.005781884,0.001603063,0.005757681
+2454,0.005629174,0.002076631,0.00483693
+2455,0.005771693,0.001639379,0.006345834
+2456,0.005770112,0.001644934,0.006905744
+2457,0.00558955,0.002181039,0.006020039
+2458,0.00577171,0.001639318,0.007471935
+2459,0.005772579,0.001636256,0.008038179
+2460,0.005577883,0.002210707,0.007174382
+2461,0.005775822,0.001624772,0.008611383
+2462,0.005782338,0.001601426,0.009155244
+2463,0.005584407,0.002194175,0.008313778
+2464,0.005788036,0.001580709,0.009690961
+2465,0.005788578,0.001578722,0.010245
+2466,0.005596541,0.002163036,0.009422699
+2467,0.005794441,0.001557066,0.01080716
+2468,0.005789717,0.001574541,0.01137722
+2469,0.005612226,0.002122009,0.01052058
+2470,0.005776097,0.001623794,0.01194192
+2471,0.005772606,0.001636159,0.01250002
+2472,0.005602024,0.002148798,0.01164745
+2473,0.005753291,0.001702834,0.01304091
+2474,0.00574924,0.00171646,0.01358159
+2475,0.005557734,0.002260882,0.01275305
+2476,0.005758046,0.001686685,0.0141326
+2477,0.005759752,0.001680851,0.01468734
+2478,0.005543164,0.002296375,0.01384495
+2479,0.005765775,0.001660071,0.01525943
+2480,0.005768378,0.001651006,0.01582267
+2481,0.005563114,0.002247613,0.01496806
+2482,0.005772792,0.001635502,0.01636878
+2483,0.005777602,0.00161843,0.01691443
+2484,0.005577147,0.002212562,0.01608626
+2485,0.005779251,0.00161253,0.01748242
+2486,0.005777924,0.00161728,0.01803936
+2487,0.005585312,0.002191869,0.01720036
+2488,0.005771521,0.001639985,0.01859264
+2489,0.005768559,0.001650373,0.01915266
+2490,0.005578908,0.002208117,0.01832162
+2491,0.005776052,0.001623952,0.01970594
+2492,0.005778911,0.001613749,0.02026712
+2493,0.005580333,0.002204515,0.01942819
+2494,0.00577915,0.001612893,0.02083497
+2495,0.005777857,0.00161752,0.02138446
+2496,0.005590688,0.002178121,0.02054932
+2497,0.005775277,0.001626708,0.02192437
+2498,0.005773528,0.001632903,0.02247866
+2499,0.00558754,0.002186182,0.02165707
+2500,0.005770342,0.001644125,0.02304415
+2501,0.005769187,0.001648174,0.02360473
+2502,0.005579778,0.002205919,0.02276246
+2503,0.005763758,0.001667061,0.02414992
+2504,0.005769361,0.001647564,0.02468666
+2505,0.005568188,0.002235013,0.02387312
+2506,0.005781821,0.001603292,0.02523179
+2507,0.005783249,0.001598132,0.02578673
+2508,0.005577946,0.002210547,0.02496343
+2509,0.005787613,0.001582257,0.02635499
+2510,0.005785683,0.001589301,0.02691931
+2511,0.005600654,0.002152365,0.02607682
+2512,0.005783407,0.00159756,0.02746294
+2513,0.005784537,0.001593464,0.02801968
+2514,0.005603482,0.002144992,0.02718871
+2515,0.005783618,0.001596798,0.02857637
+2516,0.005782569,0.001600591,0.02912208
+2517,0.005599172,0.002156218,0.02828903
+2518,0.005784209,0.001594657,0.02966065
+2519,0.005783431,0.001597475,0.03021573
+2520,0.005600141,0.0021537,0.0293843
+2521,0.005781393,0.001604836,0.03078106
+2522,0.005780444,0.001608251,0.03134358
+2523,0.005599609,0.002155081,0.03048821
+2524,0.005777792,0.001617753,0.03188609
+2525,0.005779461,0.001611778,0.03243091
+2526,0.005593299,0.002171406,0.03159605
+2527,0.005773362,0.00163349,0.03299636
+2528,0.005768978,0.001648907,0.03355474
+2529,0.005581486,0.002201594,0.03270402
+2530,0.005755656,0.001694824,0.0341136
+2531,0.005751408,0.001709182,0.03467807
+2532,0.005555284,0.002266897,0.03382833
+2533,0.005752312,0.001706137,0.03524307
+2534,0.005758063,0.001686627,0.03578791
+2535,0.005538267,0.00230816,0.03495218
+2536,0.005774399,0.001629819,0.03634025
+2537,0.005774974,0.001627784,0.03689644
+2538,0.005561929,0.002250544,0.03606951
+2539,0.005779601,0.001611275,0.03746783
+2540,0.005781879,0.001603081,0.03802721
+2541,0.005590081,0.002179676,0.03719325
+2542,0.005785446,0.001590162,0.03857123
+2543,0.005785442,0.001590177,0.03913739
+2544,0.005601106,0.002151187,0.03830866
+2545,0.005785827,0.001588775,0.03970512
+2546,0.005789525,0.001575247,0.04025386
+2547,0.005606416,0.002137312,0.03942041
+2548,0.005787706,0.001581915,0.04080135
+2549,0.005782681,0.001600186,0.04137381
+2550,0.00560447,0.00214241,0.04053563
+2551,0.005777882,0.001617431,0.04195621
+2552,0.005778603,0.001614853,0.04250822
+2553,0.005595562,0.002165567,0.04166551
+2554,0.005772644,0.001636027,0.04308415
+2555,0.005769151,0.001648302,0.04364788
+2556,0.005581039,0.002202727,0.04282383
+2557,0.005774262,0.001630305,0.044247
+2558,0.005779514,0.00161159,0.04481866
+2559,0.005579831,0.002205784,0.04399888
+2560,0.005799239,0.001539099,0.04542171
+2561,0.005806023,0.001513308,0.04598686
+2562,0.005613645,0.002118252,0.04520105
+2563,0.005827878,0.001426828,0.04655601
+2564,0.005836327,0.001391864,0.04709149
+2565,0.005729502,0.001781239,0.04749874
+2566,0.005669547,0.001963731,0.04637324
+2567,0.005864677,0.001267108,0.002367785
+2568,-0.005208958,0.002977709,0.002294024
+2569,-0.004901154,0.003461024,0.002332475
+2570,-0.005455025,0.002498541,0.002965049
+2571,0.00585934,-0.001291562,0.04773339
+2572,0.005579334,0.00220704,0.04798803
+2573,0.005597606,-0.002160278,0.03495528
+2574,0.005414722,-0.002584721,0.03435864
+2575,0.00541457,-0.00258504,0.03555267
+2576,0.005602236,-0.002148244,0.01157941
+2577,0.005430634,-0.00255112,0.01096128
+2578,0.005409126,-0.002596411,0.01215864
+2579,-0.005552066,-0.002274768,0.002561592
+2580,-0.005580268,-0.002204679,0.001799415
+2581,0.005631209,-0.002071108,0.02714284
+2582,0.005458166,-0.002491671,0.02653111
+2583,0.005457124,-0.002493952,0.02772608
+2584,0.005354497,-0.00270728,0.01638978
+2585,0.005663708,-0.001980508,0.01457931
+2586,0.00567846,-0.001937805,0.01399474
+2587,0.005477885,-0.002448014,0.01348504
+2588,0.005339799,-0.002736156,0.01491139
+2589,0.005569855,-0.002230854,0.01929224
+2590,0.00564414,-0.002035605,0.02153963
+2591,0.005418315,-0.002577182,0.02086
+2592,0.005636164,-0.002057586,0.02213011
+2593,0.00536479,-0.002686825,0.02387217
+2594,0.005696787,-0.001883247,0.02949706
+2595,0.005512526,-0.002368979,0.02900054
+2596,0.005679713,-0.001934131,0.0300675
+2597,0.005387137,-0.002641734,0.03171716
+2598,0.005491305,-0.002417762,0.04164804
+2599,0.005700663,-0.00187148,0.03733309
+2600,0.005509076,-0.002376989,0.03684654
+2601,0.00568553,-0.001916964,0.0379164
+2602,0.005439498,-0.002532165,0.03986339
+2603,0.005709766,-0.001843523,0.04402382
+2604,0.005482897,-0.002436769,0.04344819
+2605,0.005720614,-0.001809578,0.04460954
+2606,0.001051901,0.005907072,0.002280963
+2607,-0.0005126417,0.00597806,0.001831077
+2608,-0.0001369782,0.005998436,0.002496189
+2609,-0.001049973,0.005907415,0.001859538
+2610,0.005585839,0.002190525,0.002079988
+2611,-0.002116493,0.005614308,0.002037174
+2612,-0.001615831,0.005778329,0.002034926
+2613,-0.001310536,0.005855126,0.002654878
+2614,-0.002483251,0.005462002,0.00266773
+2615,-0.004644545,0.003798447,0.003239966
+2616,-0.004421997,0.004055359,0.002386826
+2617,-0.003951659,0.004514907,0.001382759
+2618,-0.003580983,0.004814204,0.0014792
+2619,-0.003485605,0.004883703,0.002205461
+2620,-0.004309553,0.004174656,0.001692531
+2621,-0.002741893,-0.005336855,0.001939817
+2622,-0.002976005,-0.005209932,0.002567671
+2623,-0.002267624,-0.005554987,0.001937264
+2624,-0.004520993,-0.003944696,0.002052702
+2625,-0.004813482,-0.003581954,0.002787564
+2626,-0.004143607,-0.004339414,0.002011446
+2627,-0.005730794,-0.001777077,0.001619294
+2628,-0.003932761,-0.004531378,0.002625045
+2629,-0.001641651,-0.005771047,0.001817093
+2630,0.0005128675,-0.00597804,0.001978302
+2631,-0.00001499778,-0.005999981,0.001942417
+2632,0.001672824,-0.005762088,0.00204403
+2633,0.001156633,-0.005887461,0.002044971
+2634,0.003638384,-0.004770971,0.001662926
+2635,0.003207657,-0.005070595,0.001724126
+2636,0.00311555,-0.005127704,0.002482197
+2637,0.004021413,-0.004452891,0.002211711
+2638,0.004862987,-0.00351445,0.002177281
+2639,0.005787352,-0.00158321,0.003561761
+2640,0.00579902,-0.001539924,0.003006375
+2641,0.005667628,-0.001969262,0.002607486
+2642,0.005576446,-0.002214328,0.003830857
+2643,0.005736112,0.001759836,0.002546697
+2644,-0.001830782,-0.005713864,0.002546626
+2645,-0.0005125832,-0.005978065,0.002541394
+2646,0.005315478,-0.002783108,0.02239606
+2647,0.005386824,-0.002642371,0.03034439
+2648,0.005412051,-0.00259031,0.03828441
+2649,0.005535134,-0.002315662,0.04504712
+2650,-0.004004033,0.004468526,0.002600023
+2651,0.002064556,-0.005633614,0.00274577
+2652,0.0008193443,-0.005943793,0.002723002
+2653,-0.001926767,0.005682215,0.01713751
+2654,-0.002069545,0.005631783,0.018287
+2655,0.005540666,0.002302394,0.04743168
+2656,0.004588783,0.003865626,0.04719718
+2657,0.004212338,0.004272729,0.04719448
+2658,0.003655438,0.004757917,0.04723438
+2659,0.003240748,0.00504951,0.04733992
+2660,0.003885452,0.004572009,0.04659371
+2661,0.0028234,0.005294187,0.04721178
+2662,-0.0009210102,0.00592889,0.01900741
+2663,0.002215918,0.005575814,0.04707655
+2664,0.001710547,0.005751002,0.047057
+2665,0.002714977,0.005350598,0.04649838
+2666,0.0010625,0.005905175,0.0470827
+2667,0.0005291215,0.005976624,0.04713187
+2668,0.001465971,0.005818155,0.04638885
+2669,-0.00001338549,0.005999985,0.04727652
+2670,-0.000561357,0.005973682,0.04728245
+2671,0.0002711985,0.005993868,0.0465592
+2672,-0.001073671,0.005903154,0.04716649
+2673,-0.001588286,0.005785961,0.04711938
+2674,-0.0007869365,0.00594817,0.0465879
+2675,-0.002122084,0.005612198,0.0470441
+2676,-0.002610196,0.005402488,0.04701174
+2677,-0.001838053,0.005711529,0.04639665
+2678,-0.003115409,0.00512779,0.04699042
+2679,-0.003559908,0.004829809,0.04697692
+2680,-0.002880894,0.005263122,0.04630005
+2681,-0.004065151,0.004412998,0.04699014
+2682,-0.004435319,0.004040785,0.04702842
+2683,-0.003892421,0.004566077,0.04629194
+2684,-0.004855879,0.003524265,0.04712924
+2685,-0.005116732,0.003133536,0.04726126
+2686,-0.004796097,0.003605198,0.04640598
+2687,-0.005353468,0.002709313,0.04718025
+2688,-0.005197776,0.002997187,0.0387421
+2689,-0.005693563,0.001892971,0.03878988
+2690,-0.005627262,0.002081808,0.04721525
+2691,-0.005788412,0.001579331,0.04719893
+2692,-0.005480133,0.002442979,0.0465418
+2693,-0.005931618,0.0009032769,0.04714218
+2694,-0.005985134,0.0004220965,0.04722826
+2695,-0.005892095,0.001132791,0.04652005
+2696,-0.005999756,-0.00005410443,0.0470939
+2697,-0.002215189,-0.005576104,0.03515758
+2698,-0.002387285,-0.005504623,0.03395049
+2699,-0.005953251,-0.0007475273,0.0469677
+2700,-0.005866562,-0.00125835,0.0469855
+2701,-0.005994909,-0.0002471064,0.04633709
+2702,-0.00571881,-0.001815272,0.04717417
+2703,-0.005533366,-0.002319885,0.047198
+2704,-0.005808756,-0.001502782,0.04639956
+2705,-0.005297692,-0.002816818,0.04710368
+2706,-0.005041785,-0.003252753,0.04712818
+2707,-0.005426146,-0.002560651,0.04649391
+2708,-0.004758452,-0.003654741,0.04727071
+2709,-0.004418808,-0.004058835,0.04726017
+2710,-0.004901987,-0.003459844,0.04654211
+2711,-0.004071788,-0.004406875,0.04709668
+2712,-0.003685986,-0.004734291,0.04705611
+2713,-0.004271646,-0.004213436,0.04652115
+2714,-0.003214508,-0.005066255,0.04705944
+2715,-0.002771434,-0.005321574,0.04708502
+2716,-0.003457737,-0.004903474,0.04636099
+2717,-0.002299352,-0.005541929,0.0472265
+2718,-0.001795627,-0.005725009,0.04722177
+2719,-0.002507679,-0.00545083,0.0465058
+2720,-0.001256843,-0.005866886,0.04706492
+2721,-0.0007493836,-0.005953018,0.04702736
+2722,-0.001492765,-0.005811338,0.04649044
+2723,-0.00003948997,-0.00599987,0.04703505
+2724,0.000438269,-0.005983972,0.04713425
+2725,-0.0002393406,-0.005995224,0.04634128
+2726,0.0009306183,-0.00592739,0.0470083
+2727,-0.003377894,0.004958814,0.01317466
+2728,-0.00267659,0.005369904,0.01463004
+2729,0.00172135,-0.005747778,0.0469007
+2730,0.002226011,-0.005571793,0.04691699
+2731,0.001274167,-0.005863147,0.04624137
+2732,0.002919132,-0.00524201,0.04714993
+2733,0.00332268,-0.004995978,0.0473281
+2734,0.002756062,-0.005329552,0.04636671
+2735,0.003716152,-0.004710649,0.04727978
+2736,-0.00500228,0.003313185,0.04002719
+2737,0.004266343,-0.004218805,0.04741381
+2738,0.004613917,-0.003835592,0.04742869
+2739,0.003993826,-0.004477651,0.04673366
+2740,0.005017357,-0.003290308,0.04747061
+2741,0.005251058,-0.002902825,0.04758352
+2742,0.004930702,-0.003418798,0.04690961
+2743,0.001554618,0.005795098,0.002939566
+2744,0.002100717,0.00562023,0.003178082
+2745,0.0009774058,0.005919855,0.003171492
+2746,-0.005409402,-0.002595838,0.003791651
+2747,-0.005703912,-0.001861554,0.00355966
+2748,0.005172122,-0.003041243,0.006166952
+2749,0.005253665,-0.002898104,0.005603412
+2750,0.004823159,-0.003568912,0.03053047
+2751,0.004861866,-0.003516,0.02985034
+2752,0.005177136,-0.003032699,0.01931204
+2753,0.005259363,-0.00288775,0.01851096
+2754,0.005117969,-0.003131515,0.01782978
+2755,0.004956096,-0.003381879,0.03852161
+2756,0.004977104,-0.003350886,0.03777629
+2757,0.004914636,-0.003441853,0.02434763
+2758,0.00484073,-0.003545043,0.02364087
+2759,0.005118839,-0.003130094,0.02909877
+2760,0.005237662,-0.002926927,0.02843505
+2761,0.005046199,-0.003245901,0.02782431
+2762,0.004471755,-0.004000426,0.02928485
+2763,0.00523897,-0.002924585,0.02577911
+2764,0.005121993,-0.00312493,0.02509514
+2765,0.005046294,-0.003245754,0.02636334
+2766,0.004886844,-0.003481201,0.01692244
+2767,0.004812668,-0.003583047,0.01618343
+2768,0.005079542,-0.00319347,0.04214187
+2769,0.005066809,-0.003213634,0.04119087
+2770,0.00520222,-0.002989466,0.03362783
+2771,0.005093667,-0.003170892,0.03294976
+2772,0.004977152,-0.003350814,0.03422054
+2773,0.005014122,-0.003295236,0.04028416
+2774,0.004957527,-0.003379782,0.0394505
+2775,0.00441245,-0.004065745,0.03894238
+2776,0.00447938,-0.003991887,0.04077799
+2777,0.005105726,-0.003151437,0.03697719
+2778,0.005206389,-0.002982199,0.03628463
+2779,0.004982023,-0.003343568,0.03568332
+2780,0.004568139,-0.003890001,0.03721439
+2781,-0.003617728,0.004786653,0.002899756
+2782,-0.004756396,0.003657416,0.004225732
+2783,-0.004253474,0.00423178,0.004280083
+2784,0.005634949,-0.002060911,0.04703869
+2785,0.005453844,-0.002501116,0.04637421
+2786,0.005209184,-0.002977314,0.005032577
+2787,0.004863179,-0.003514184,0.02094239
+2788,0.004983974,-0.003340659,0.0201757
+2789,0.005240776,-0.002921348,0.01012524
+2790,0.005169985,-0.003044874,0.009451381
+2791,0.005012837,-0.00329719,0.01068315
+2792,0.005547757,0.002285254,0.00263749
+2793,0.005284549,0.002841397,0.0473188
+2794,0.004994824,0.003324414,0.04727859
+2795,0.004846776,0.003536774,0.04663522
+2796,0.005483253,0.002435967,0.04682951
+2797,0.00476869,-0.003641373,0.02267598
+2798,0.004780046,-0.003626453,0.02190662
+2799,0.004185462,-0.004299059,0.02315144
+2800,0.00543412,-0.002543686,0.002703476
+2801,0.005415324,0.00258346,0.004452775
+2802,0.005383069,0.002650013,0.005047731
+2803,0.005325916,0.002763082,0.005684414
+2804,0.005308441,0.002796508,0.006272567
+2805,0.00505047,0.003239251,0.005300259
+2806,0.005251769,0.002901538,0.006896783
+2807,0.00525459,0.002896426,0.007462975
+2808,0.00491343,0.003443574,0.006561159
+2809,0.005318174,0.002777954,0.008042653
+2810,0.005323688,0.002767371,0.008615857
+2811,0.004922088,0.003431188,0.007765054
+2812,0.005269031,0.002870072,0.009190828
+2813,0.005279275,0.002851185,0.009726545
+2814,0.004932426,0.00341631,0.008919703
+2815,0.005378835,0.002658595,0.01023705
+2816,0.005388739,0.002638463,0.01079922
+2817,0.004988939,0.003333239,0.01000518
+2818,0.00537381,0.002668738,0.01130486
+2819,0.005350886,0.002714409,0.01186956
+2820,0.005088298,0.003179501,0.01102133
+2821,0.00522444,0.002950462,0.01238581
+2822,0.005189955,0.003010708,0.01292671
+2823,0.004922135,0.00343112,0.01204322
+2824,0.005175972,0.003034685,0.01356637
+2825,0.005191607,0.003007859,0.01411738
+2826,0.004747213,0.003669329,0.01319913
+2827,0.005284747,0.002841029,0.01468526
+2828,0.005294957,0.002821954,0.01525735
+2829,0.004845321,0.003538766,0.01440667
+2830,0.005239688,0.002923297,0.01581667
+2831,0.005247523,0.00290921,0.01636279
+2832,0.004889547,0.003477403,0.01553388
+2833,0.005321689,0.002771213,0.01691212
+2834,0.005324516,0.002765779,0.01748011
+2835,0.004913329,0.003443719,0.01664253
+2836,0.005268215,0.002871569,0.01803174
+2837,0.005256884,0.00289226,0.01858502
+2838,0.004934373,0.003413497,0.0177435
+2839,0.005260405,0.002885851,0.01918484
+2840,0.00527356,0.002861742,0.01973812
+2841,0.004869489,0.003505435,0.01889495
+2842,0.005334443,0.002746583,0.02027717
+2843,0.00533485,0.002745793,0.02084501
+2844,0.004948581,0.003392867,0.02003382
+2845,0.005261621,0.002883633,0.02138796
+2846,0.005257028,0.002891998,0.02192786
+2847,0.004933933,0.003414134,0.02111581
+2848,0.005317237,0.002779747,0.02247469
+2849,0.005311822,0.00279008,0.02304017
+2850,0.004917541,0.003437702,0.02220558
+2851,0.005234276,0.002932977,0.02359103
+2852,0.005224641,0.002950105,0.02413621
+2853,0.004897285,0.003466497,0.02330326
+2854,0.005257306,0.002891494,0.02474268
+2855,0.005279316,0.00285111,0.02528781
+2856,0.004841499,0.003543993,0.02446059
+2857,0.005371487,0.002673412,0.02581408
+2858,0.005378802,0.002658662,0.02638234
+2859,0.004994522,0.003324868,0.02559332
+2860,0.005319119,0.002776143,0.02692607
+2861,0.00531515,0.002783735,0.0274697
+2862,0.005032108,0.003267703,0.02666333
+2863,0.005360187,0.002695997,0.02800987
+2864,0.005358632,0.002699086,0.02856656
+2865,0.005013977,0.003295457,0.02774723
+2866,0.005306498,0.002800192,0.02910432
+2867,0.005309369,0.002794745,0.02964289
+2868,0.005005648,0.003308094,0.02882515
+2869,0.005374675,0.002666996,0.03018414
+2870,0.005371276,0.002673835,0.03074948
+2871,0.005021973,0.003283259,0.02990416
+2872,0.005288419,0.002834189,0.03127269
+2873,0.005283752,0.00284288,0.0318152
+2874,0.005001617,0.003314186,0.03096862
+2875,0.005319441,0.002775527,0.03236972
+2876,0.00530897,0.002795502,0.03293517
+2877,0.004943265,0.003400607,0.03204635
+2878,0.005237359,0.002927468,0.03347383
+2879,0.005213865,0.002969109,0.03403269
+2880,0.004900993,0.003461252,0.03313954
+2881,0.005194427,0.003002986,0.03466726
+2882,0.005196017,0.003000235,0.03523226
+2883,0.004789427,0.003614055,0.03431277
+2884,0.005216819,0.002963917,0.03585795
+2885,0.005245764,0.00291238,0.03641029
+2886,0.004791111,0.003611822,0.03557303
+2887,0.005343364,0.002729187,0.03695381
+2888,0.005351141,0.002713907,0.03752521
+2889,0.00493708,0.003409581,0.03674225
+2890,0.005307073,0.002799103,0.03806705
+2891,0.005313312,0.002787241,0.03861107
+2892,0.004999674,0.003317116,0.03782761
+2893,0.005380527,0.002655171,0.03914153
+2894,0.00538117,0.002653867,0.03970926
+2895,0.005028384,0.003273431,0.03889992
+2896,0.005315571,0.002782932,0.04025005
+2897,0.005312362,0.002789052,0.04079754
+2898,0.005030244,0.003270572,0.03997117
+2899,0.005368134,0.002680138,0.04135793
+2900,0.005360114,0.002696142,0.04194032
+2901,0.00501799,0.003289343,0.04107235
+2902,0.005285317,0.002839969,0.04250657
+2903,0.00527487,0.002859327,0.0430825
+2904,0.004996086,0.003322517,0.04219899
+2905,0.005292135,0.002827244,0.04375793
+2906,0.005300925,0.002810728,0.04435705
+2907,0.004925397,0.003426437,0.04344066
+2908,0.005352732,0.002710768,0.04501761
+2909,0.005386253,0.002643534,0.04562065
+2910,0.005008971,0.00330306,0.04477665
+2911,0.005492936,0.002414054,0.003260415
+2912,0.005460604,0.002486322,0.003829302
+2913,0.005172862,0.003039983,0.004040103
+2914,0.005293665,0.002824378,0.002793706
+2915,0.004981258,0.003344707,0.002884359
+2916,0.005757084,-0.001689966,0.04758833
+2917,0.005458661,-0.002490587,0.04750117
+2918,-0.003440855,0.004915335,0.004050471
+2919,-0.002876493,0.005265528,0.00365591
+2920,-0.003586751,0.004809908,0.005036237
+2921,0.00514958,-0.003079257,0.01287228
+2922,0.004938968,-0.003406846,0.01223283
+2923,-0.00000920152,0.005999993,0.003469427
+2924,0.0005053945,0.005978677,0.004128031
+2925,0.004543631,-0.003918599,0.01939442
+2926,0.004528177,-0.003936446,0.02486384
+2927,0.004507078,-0.003960587,0.01762343
+2928,0.005320106,-0.002774252,0.00343802
+2929,0.00509019,-0.00317647,0.002928209
+2930,0.004707891,-0.003719645,0.002911825
+2931,0.005270955,-0.002866538,0.004055591
+2932,0.005220264,-0.002957844,0.04558028
+2933,0.005130994,-0.003110128,0.04483051
+2934,0.00493945,-0.003406147,0.03214019
+2935,0.004901529,-0.003460493,0.03144756
+2936,0.004528063,-0.003936578,0.03268016
+2937,0.004566438,0.003891997,0.003029844
+2938,0.004855344,0.003525002,0.003562115
+2939,0.004110797,0.004370509,0.003129424
+2940,0.005076439,-0.0031984,0.04392372
+2941,0.00510009,-0.00316055,0.04307456
+2942,0.005023127,-0.003281493,0.0461576
+2943,0.004876572,-0.003495576,0.00463974
+2944,0.004199348,-0.004285496,0.02122231
+2945,-0.0006117124,0.005968736,0.003452728
+2946,0.004738164,-0.003681006,0.008846708
+2947,0.005141371,-0.003092944,0.008450978
+2948,0.004568666,-0.003889382,0.0426174
+2949,-0.003459108,-0.004902507,0.003354321
+2950,-0.003919088,-0.00454321,0.003510822
+2951,0.002517199,-0.00544644,0.003660767
+2952,0.001927495,-0.005681968,0.003704668
+2953,-0.002960291,-0.005218877,0.003453448
+2954,-0.00589375,-0.001124148,0.003272867
+2955,-0.005993603,-0.0002769965,0.003475912
+2956,-0.005817848,-0.00146719,0.004502926
+2957,-0.0001844488,-0.005997164,0.003372742
+2958,-0.0008661369,-0.005937155,0.003257804
+2959,0.004245101,-0.004240179,0.03095351
+2960,0.005130981,-0.00311015,0.007281742
+2961,0.004753041,-0.003661776,0.006731516
+2962,-0.004550988,-0.003910052,0.003763161
+2963,-0.004982801,-0.003342408,0.003769179
+2964,-0.004136459,-0.004346229,0.004492437
+2965,0.00115987,-0.005886824,0.003682757
+2966,0.0005161539,-0.005977758,0.003616088
+2967,0.001636181,-0.0057726,0.004597754
+2968,-0.001511407,-0.005806518,0.03629928
+2969,-0.001231849,-0.005872184,0.004260285
+2970,-0.001551567,-0.005795916,0.003428936
+2971,0.00465979,-0.00377973,0.04445688
+2972,0.002285322,0.00554773,0.004113234
+2973,0.002871064,0.00526849,0.003461221
+2974,0.005446434,0.002517212,0.04626036
+2975,-0.005978567,0.0005066882,0.003801562
+2976,-0.005853914,0.001315938,0.003805958
+2977,-0.005999657,0.00006412869,0.004541783
+2978,-0.005606804,0.002136294,0.003928369
+2979,-0.005286289,0.002838159,0.004148934
+2980,-0.002180829,-0.005589632,0.003549107
+2981,-0.002703749,-0.005356281,0.004335758
+2982,-0.002110877,0.005616422,0.01570838
+2983,0.005143508,0.003089389,0.04607692
+2984,0.001661393,0.005765394,0.01033857
+2985,0.002850844,0.005279459,0.01119779
+2986,0.002825503,0.005293065,0.009974431
+2987,-0.00575909,0.001683118,0.004989843
+2988,-0.004985491,0.003338394,0.005189052
+2989,-0.005214462,-0.002968061,0.004767248
+2990,-0.003884021,0.004573224,0.00625199
+2991,-0.003016997,0.005186302,0.006022378
+2992,0.003373927,-0.004961514,0.02372275
+2993,0.003273785,-0.005028154,0.02275786
+2994,-0.001185545,0.005881707,0.003628116
+2995,-0.002282517,0.005548884,0.003818445
+2996,-0.001613,0.00577912,0.004616295
+2997,0.003080542,0.005148812,0.0456852
+2998,0.002487657,0.005459997,0.04554997
+2999,-0.003673366,0.004744089,0.04546874
+3000,-0.004168589,0.004315422,0.04548196
+3001,-0.005737816,0.001754271,0.04558198
+3002,-0.005901473,0.001082875,0.04552522
+3003,-0.005599801,-0.002154583,0.04557326
+3004,-0.005378984,-0.002658294,0.04547894
+3005,0.004620645,-0.003827485,0.04611568
+3006,0.003537143,-0.004846506,0.01928336
+3007,0.003824154,-0.004623402,0.0184197
+3008,0.004182791,-0.004301658,0.01569754
+3009,0.004781737,-0.003624223,0.01516488
+3010,0.00502999,-0.003270963,0.01355924
+3011,0.005199204,-0.002994709,0.007855099
+3012,0.004837688,-0.003549194,0.0144255
+3013,0.00326583,-0.005033325,0.02152395
+3014,0.003382127,-0.004955927,0.02055972
+3015,0.0023406,-0.005524635,0.02209527
+3016,0.00438353,-0.004096909,0.01381273
+3017,0.004591327,-0.003862605,0.0349365
+3018,0.004283923,-0.004200953,0.03420568
+3019,0.004290032,-0.004194714,0.03566846
+3020,0.0001608085,-0.005997845,0.004332498
+3021,0.004421061,-0.004056381,0.003839099
+3022,0.004135709,-0.004346943,0.00308817
+3023,0.004044671,-0.004431776,0.007277621
+3024,0.004103585,-0.004377281,0.006162831
+3025,0.003938634,-0.004526274,0.03336406
+3026,0.00372216,-0.004705903,0.0325545
+3027,0.003492025,-0.004879115,0.01751236
+3028,-0.004950226,-0.003390466,0.005972099
+3029,-0.005384031,-0.002648059,0.00599457
+3030,0.004795689,-0.003605741,0.02704972
+3031,0.004488634,-0.003981478,0.02629772
+3032,0.004488518,-0.003981609,0.02775869
+3033,0.003247678,-0.005045055,0.003358656
+3034,0.003124527,-0.005122239,0.004317555
+3035,0.003929966,-0.004533803,0.009701557
+3036,0.003887524,-0.004570247,0.008701155
+3037,0.003420648,0.004929418,0.003473811
+3038,0.00377352,0.00466482,0.004051987
+3039,0.002252577,0.005561106,0.0394469
+3040,0.001163081,0.005886191,0.03856761
+3041,0.001048409,0.005907693,0.03951377
+3042,0.003908521,-0.004552303,0.04315904
+3043,0.003878996,-0.004577487,0.04222634
+3044,0.004762983,0.003648835,0.04599551
+3045,-0.001800489,0.005723482,0.006052103
+3046,-0.0006791092,0.005961444,0.005861774
+3047,-0.002159169,0.005598034,0.007267856
+3048,-0.005894859,0.001118319,0.006029764
+3049,-0.005675478,0.001946521,0.006152175
+3050,0.003682428,-0.004737059,0.003138985
+3051,0.003311075,-0.005003677,0.01609892
+3052,0.003268005,-0.005031913,0.01508037
+3053,0.004334329,-0.004148927,0.004816085
+3054,0.003479329,-0.004888177,0.03159855
+3055,0.003369482,-0.004964533,0.03068146
+3056,0.002768109,-0.005323304,0.03228245
+3057,0.001555663,0.005794818,0.005120745
+3058,0.002356019,0.005518077,0.005403885
+3059,0.0005817439,0.005971731,0.005418681
+3060,0.004791608,0.003611163,0.004185588
+3061,0.004388112,0.004092002,0.006175176
+3062,0.004305854,0.004178471,0.006799393
+3063,0.004408381,0.004070157,0.01016416
+3064,0.004552548,0.003908235,0.01067467
+3065,0.004119231,0.004362561,0.01276738
+3066,0.004099005,0.00438157,0.01340704
+3067,0.004205443,0.004279515,0.01445572
+3068,0.004339574,0.004143441,0.0150236
+3069,0.003489209,0.004881129,0.01402397
+3070,0.004398532,0.004080799,0.01716791
+3071,0.004316152,0.004167833,0.01771954
+3072,0.004424335,0.004052809,0.02061554
+3073,0.004317417,0.004166523,0.02115848
+3074,0.004291449,0.004193264,0.02216613
+3075,0.004379499,0.004101218,0.02271296
+3076,0.003681955,0.004737426,0.02166586
+3077,0.004493428,0.003976067,0.02567817
+3078,0.004623564,0.003823959,0.02620444
+3079,0.004448334,0.004026453,0.02827982
+3080,0.0043712,0.004110062,0.02881757
+3081,0.004516053,0.00395035,0.02985497
+3082,0.004609216,0.00384124,0.03039622
+3083,0.003867316,0.004587359,0.02930964
+3084,0.004320607,0.004163215,0.03244307
+3085,0.004215082,0.004270022,0.03298173
+3086,0.004376786,0.004104113,0.03684467
+3087,0.004516128,0.003950265,0.03738819
+3088,0.004452402,0.004021954,0.03793004
+3089,-0.001033391,0.005910339,0.0216952
+3090,-0.002299637,0.005541811,0.02231107
+3091,0.004573152,0.003884106,0.04156394
+3092,0.004466548,0.004006239,0.04213019
+3093,0.004433482,0.004042801,0.04306193
+3094,0.004457949,0.004015805,0.04373736
+3095,0.003930158,0.004533636,0.04242688
+3096,0.004566158,0.003892326,0.04462145
+3097,0.004638389,0.003805962,0.04528201
+3098,0.004279627,0.004205329,0.0458403
+3099,0.004016246,0.004457552,0.04424271
+3100,0.0035477,-0.004838783,0.00536219
+3101,0.004354809,0.004127425,0.004391247
+3102,0.004732801,0.003687898,0.004869235
+3103,0.004653879,0.003787005,0.005505918
+3104,0.003697869,0.004725015,0.004735634
+3105,0.001729995,0.005745182,0.04547848
+3106,0.001082473,0.005901547,0.04550418
+3107,0.002125388,0.005610947,0.0446653
+3108,0.0002852884,0.005993214,0.04570799
+3109,-0.00025772,0.005994462,0.04585264
+3110,0.0005585326,0.005973947,0.04479762
+3111,-0.0007729511,0.005950004,0.04573669
+3112,-0.001395065,-0.005835563,0.04258736
+3113,-0.002244905,-0.005564207,0.04183376
+3114,-0.001307922,-0.00585571,0.04143964
+3115,-0.001478386,0.005815013,0.04571846
+3116,-0.002015379,0.005651393,0.04564318
+3117,-0.0009582371,0.005922988,0.04498321
+3118,-0.002593274,0.005410631,0.04537779
+3119,-0.003099345,0.005137515,0.04535647
+3120,-0.002250897,0.005561786,0.0446996
+3121,-0.004675638,0.003760108,0.04532004
+3122,-0.005063606,0.00321868,0.04542086
+3123,-0.004493622,0.003975847,0.04449683
+3124,-0.003573277,-0.004819927,0.01863807
+3125,-0.003692066,-0.004729551,0.01711611
+3126,-0.003959041,0.004508436,0.01200586
+3127,-0.005500616,0.002396504,0.04554698
+3128,-0.005419305,0.002575098,0.04446103
+3129,-0.005754228,-0.001699664,0.03861859
+3130,-0.003729497,-0.004700091,0.01563492
+3131,-0.003741374,-0.004690642,0.01408459
+3132,-0.005999597,0.00006956859,0.04535323
+3133,-0.005967394,-0.0006246655,0.04522703
+3134,-0.005958015,0.0007085609,0.04441516
+3135,-0.005780649,-0.001607512,0.04538459
+3136,-0.005857419,-0.001300248,0.04440073
+3137,-0.004931024,-0.003418333,0.04570231
+3138,-0.004634502,-0.003810694,0.04584484
+3139,-0.005169108,-0.003046361,0.04478167
+3140,-0.004307067,-0.00417722,0.04568135
+3141,-0.002668173,-0.005374091,0.0324752
+3142,-0.002845909,-0.005282121,0.03114142
+3143,-0.003714961,-0.004711588,0.04539913
+3144,-0.003245529,-0.005046439,0.04540246
+3145,-0.004125051,-0.004357058,0.04472281
+3146,-0.002527456,-0.005441688,0.04572446
+3147,-0.002045874,-0.005640425,0.04586595
+3148,-0.002814786,-0.005298771,0.0447626
+3149,-0.001513857,-0.005805879,0.0457091
+3150,-0.003028818,-0.005179408,0.02843082
+3151,-0.002932321,-0.005234644,0.02976652
+3152,-0.0007458271,-0.005953465,0.04534583
+3153,-0.00003590556,-0.005999893,0.04535352
+3154,-0.00131611,-0.005853875,0.04472134
+3155,-0.001762904,-0.005735169,0.03041241
+3156,0.0004105741,-0.005985936,0.04419509
+3157,0.0009156603,-0.005929719,0.04519054
+3158,0.001706843,-0.005752103,0.04508295
+3159,-0.002365072,0.005514203,0.02380906
+3160,0.002698895,-0.005358728,0.04539777
+3161,0.003360945,-0.004970317,0.0456307
+3162,0.002368398,-0.005512775,0.04434694
+3163,0.004115814,-0.004365784,0.04598166
+3164,0.002505501,-0.005451831,0.019585
+3165,0.003583372,-0.004812426,0.03927477
+3166,0.003581335,-0.004813942,0.03834588
+3167,-0.003722665,-0.004705503,0.005282194
+3168,-0.004380878,-0.004099745,0.005534532
+3169,-0.004620241,-0.003827973,0.006761855
+3170,-0.005248058,0.002908244,0.01084988
+3171,-0.005760476,0.001678369,0.01084583
+3172,0.003433349,-0.004920581,0.03408002
+3173,0.003103459,-0.005135031,0.00813247
+3174,0.002842911,-0.005283735,0.005664301
+3175,0.003995175,0.004476447,0.005744152
+3176,0.002478267,-0.005464265,0.01689519
+3177,0.00399201,-0.00447927,0.04410593
+3178,0.003214477,-0.005066274,0.04371487
+3179,0.003758579,-0.004676867,0.041198
+3180,0.003682375,-0.0047371,0.04029128
+3181,0.002739358,-0.005338157,0.03969478
+3182,0.002985867,-0.005204287,0.04173964
+3183,0.004680278,-0.00375433,0.0114255
+3184,0.004408837,-0.004069662,0.01058947
+3185,0.004068879,-0.00440956,0.04501272
+3186,0.003876505,-0.004579597,0.02565315
+3187,0.003579854,-0.004815044,0.02490564
+3188,0.003730499,0.004699296,0.0458802
+3189,0.003529659,0.004851959,0.04493179
+3190,0.004318093,-0.004165822,0.01213915
+3191,0.002579725,-0.005417104,0.02451206
+3192,-0.002548389,-0.005431916,0.01318472
+3193,-0.003717869,-0.004709294,0.01237519
+3194,0.004335309,0.004147903,0.02007649
+3195,0.002313285,-0.005536128,0.03041457
+3196,0.003203308,-0.005073344,0.02976953
+3197,0.004307001,0.004177289,0.007796709
+3198,0.004399524,0.004079729,0.008376387
+3199,0.003685745,0.004734478,0.007410727
+3200,0.004319595,0.004164265,0.008951359
+3201,-0.002415313,0.005492382,0.03203474
+3202,-0.002459267,0.005472842,0.03379515
+3203,0.004530489,0.003933786,0.01118031
+3204,-0.004170728,-0.004313355,0.04096966
+3205,-0.004964997,-0.003368799,0.04093474
+3206,0.004350451,0.004132018,0.01169656
+3207,-0.003741388,-0.004690631,0.01086907
+3208,-0.004729353,-0.003692318,0.01176894
+3209,-0.003228081,-0.005057618,0.02432327
+3210,-0.003314417,-0.005001464,0.02292758
+3211,0.004290489,0.004194247,0.01661858
+3212,0.004259059,0.004226159,0.01558293
+3213,-0.005872583,-0.001229948,0.01321015
+3214,-0.005993321,-0.0002830148,0.01183225
+3215,0.003643794,0.00476684,0.0161083
+3216,0.004361115,0.004120762,0.01860477
+3217,0.004366134,0.004115444,0.01920459
+3218,0.003746384,0.004686642,0.01978631
+3219,0.003730481,0.00469931,0.01802918
+3220,0.004260665,0.004224539,0.02483891
+3221,0.00380053,0.004642841,0.02545002
+3222,0.004213156,0.004271922,0.02423244
+3223,0.004266771,0.004218373,0.02326382
+3224,-0.001912189,-0.005687138,0.0276832
+3225,-0.00307894,-0.00514977,0.02707652
+3226,0.004538472,0.003924573,0.02674818
+3227,-0.003136739,-0.00511477,0.02571169
+3228,0.004381553,0.004099023,0.02773965
+3229,0.003881846,0.004575071,0.02728076
+3230,0.00449159,0.003978143,0.03091943
+3231,-0.00001398123,0.005999984,0.03989879
+3232,-0.001172578,0.005884306,0.03956895
+3233,-0.001102994,0.005897746,0.04083326
+3234,0.00426737,0.004217766,0.03188855
+3235,0.003780566,0.004659112,0.03131615
+3236,0.004261434,0.004223764,0.03389402
+3237,0.004233849,0.004251414,0.03452859
+3238,0.003572999,0.004820133,0.03319756
+3239,0.004130387,0.004352,0.03533416
+3240,0.004160645,0.004323082,0.03595986
+3241,0.003509375,0.00486665,0.03491542
+3242,0.00450618,0.003961609,0.03892687
+3243,0.004602643,0.003849114,0.03945733
+3244,0.003941596,0.004523695,0.03848745
+3245,0.004508431,0.003959047,0.03999812
+3246,0.004492993,0.003976558,0.04100355
+3247,0.003984757,0.004485724,0.04048971
+3248,0.0003868117,0.005987518,0.006854489
+3249,-0.005229489,0.002941505,0.006238671
+3250,-0.004683597,0.003750189,0.006315468
+3251,-0.00422715,0.004258075,0.007301609
+3252,-0.005489428,0.002422021,0.007278591
+3253,0.003592044,0.004805957,0.02364213
+3254,-0.002956505,-0.005221023,0.005373544
+3255,-0.003253488,-0.005041311,0.006415639
+3256,0.00378825,0.004652866,0.009620846
+3257,0.003531582,-0.00485056,0.02633953
+3258,0.003633329,0.004774822,0.01190447
+3259,-0.004793693,0.003608394,0.04116837
+3260,-0.005423874,0.002565462,0.0410934
+3261,-0.005363873,-0.002688655,0.0124321
+3262,0.0036406,0.00476928,0.0366058
+3263,-0.0006630167,0.005963255,0.04300517
+3264,-0.0007770444,0.005949471,0.042016
+3265,-0.003006645,0.00519231,0.04151596
+3266,-0.003985243,0.004485292,0.04131533
+3267,-0.001066685,0.005904421,0.01626818
+3268,-0.001677649,0.005760685,0.01107353
+3269,-0.0004478931,0.005983259,0.0113961
+3270,-0.005957034,0.000716758,0.03876958
+3271,-0.005986538,-0.0004017046,0.03879397
+3272,0.001226923,-0.005873215,0.02013052
+3273,0.001412021,-0.005831483,0.01885415
+3274,-0.005826431,-0.001432723,0.03973625
+3275,0.002424599,-0.005488289,0.01409425
+3276,0.003401745,-0.004942482,0.01369287
+3277,-0.00376995,-0.004667705,0.007439921
+3278,-0.004432166,-0.004044243,0.007877487
+3279,-0.00300903,-0.005190928,0.007531271
+3280,0.001596,-0.005783838,0.0252725
+3281,0.001351038,-0.005845913,0.02408961
+3282,-0.002270173,0.005553946,0.03520759
+3283,-0.001842402,0.005710127,0.03680582
+3284,0.001216999,-0.00587528,0.02273145
+3285,0.001207706,-0.005877197,0.02149755
+3286,0.00005669906,-0.005999732,0.0207667
+3287,0.0001742719,-0.005997469,0.02349189
+3288,0.003485832,-0.004883541,0.01044391
+3289,0.003764707,-0.004671935,0.03734464
+3290,0.003946521,-0.0045194,0.03654555
+3291,0.001930597,-0.005680915,0.03299438
+3292,0.001640735,-0.005771307,0.03203843
+3293,0.0001868857,-0.005997089,0.00541275
+3294,-0.0005137248,-0.005977967,0.005169404
+3295,0.003641721,-0.004768424,0.02904107
+3296,0.003999042,-0.004472993,0.0282895
+3297,0.003661717,-0.004753086,0.02751491
+3298,0.002619126,-0.005398164,0.02877418
+3299,-0.005666671,-0.001972014,0.006949743
+3300,-0.005810749,-0.001495057,0.005744892
+3301,-0.003412549,0.004935029,0.04454649
+3302,0.003674838,-0.004742949,0.01282661
+3303,0.003323039,-0.004995739,0.01201929
+3304,-0.002895993,0.005254829,0.008230784
+3305,-0.001667362,0.005763671,0.00826051
+3306,-0.005999896,0.00003537305,0.005783749
+3307,-0.005991903,0.0003116128,0.00694608
+3308,0.003395581,0.004946719,0.04404771
+3309,0.002834591,-0.005288203,0.03767703
+3310,0.001438642,-0.005824973,0.03085182
+3311,0.001245045,-0.005869401,0.02993989
+3312,0.0005405203,-0.005975604,0.03156375
+3313,0.00270732,0.005354477,0.006412403
+3314,0.003371066,0.004963458,0.005404892
+3315,0.001921621,-0.005683958,0.005409018
+3316,0.001153784,-0.00588802,0.005387107
+3317,-0.001206305,-0.005877485,0.005340537
+3318,0.002948221,-0.005225705,0.02687033
+3319,0.001348259,-0.005846554,0.01744283
+3320,0.001133331,-0.005891991,0.0160294
+3321,0.00001080505,-0.00599999,0.01798836
+3322,0.002748101,-0.005333661,0.01113138
+3323,-0.001485665,-0.005813157,0.006378323
+3324,-0.002176775,-0.005591212,0.005469203
+3325,-0.005463741,-0.002479423,0.008107421
+3326,-0.005854413,-0.001313714,0.007857743
+3327,0.001168191,-0.005885179,0.01457278
+3328,0.001325563,-0.005851742,0.01318528
+3329,-0.0000191955,-0.005999969,0.01512042
+3330,-0.005953309,-0.0007470702,0.005458098
+3331,0.001539817,-0.005799048,0.01176019
+3332,0.001730045,-0.005745167,0.01018481
+3333,0.0002369126,-0.005995321,0.01223871
+3334,-0.005992993,-0.0002898803,0.008038255
+3335,-0.005946808,0.0007971666,0.00828427
+3336,-0.00594176,-0.0008339573,0.009195933
+3337,0.002396769,-0.0055005,0.006453654
+3338,-0.0008979813,-0.005932422,0.007506789
+3339,-0.001882067,-0.005697177,0.007635456
+3340,0.0003889679,0.005987379,0.008206397
+3341,0.001631657,0.005773881,0.007763304
+3342,0.001699169,-0.005754374,0.03790686
+3343,0.001920293,-0.005684406,0.03690563
+3344,0.001548284,-0.005796794,0.0392202
+3345,0.0005675528,-0.005973097,0.03844879
+3346,0.002375956,-0.005509522,0.0340967
+3347,0.001219138,-0.005874836,0.03385268
+3348,0.0004853025,-0.005980341,0.006224014
+3349,-0.002475848,-0.005465361,0.008659738
+3350,0.002603962,0.005405496,0.023337
+3351,0.002535487,0.005437951,0.02430562
+3352,0.001760354,-0.005735953,0.02663438
+3353,0.0004821915,-0.005980593,0.02621192
+3354,0.001915131,-0.005686147,0.02780976
+3355,0.002710717,0.005352758,0.008761628
+3356,0.002708789,0.005353734,0.007409719
+3357,-0.001455987,0.005820662,0.03822733
+3358,0.001668133,-0.005763448,0.04023671
+3359,0.003434768,-0.004919591,0.03579872
+3360,0.003128971,0.005119525,0.04203359
+3361,0.003086803,0.00514506,0.04296533
+3362,-0.0004863055,0.00598026,0.03721296
+3363,0.002559425,0.005426725,0.0122686
+3364,0.002377545,-0.005508837,0.0358154
+3365,0.002803811,-0.005304587,0.03493832
+3366,0.001567947,0.005791506,0.03541545
+3367,0.000322234,0.005991341,0.03499131
+3368,0.0003749029,0.005988276,0.03621559
+3369,-0.003774012,0.004664422,0.008417734
+3370,-0.003356838,0.004973091,0.009410388
+3371,-0.004592961,0.003860662,0.008481212
+3372,-0.0006893762,0.005960265,0.008758189
+3373,0.0005736082,0.005972518,0.009667004
+3374,0.0006022326,0.0059697,0.01089036
+3375,-0.001488647,0.005812394,0.009721117
+3376,0.002533608,0.005438826,0.04365442
+3377,-0.003389873,-0.004950632,0.02154872
+3378,-0.003506706,-0.004868574,0.02010698
+3379,-0.002413902,-0.005493003,0.01932541
+3380,0.002029257,-0.005646425,0.00891317
+3381,0.002225098,-0.005572158,0.007489636
+3382,-0.004955346,-0.003382979,0.008731117
+3383,-0.005308435,-0.00279652,0.009639117
+3384,-0.0041866,-0.004297951,0.009409183
+3385,0.002577799,0.005418021,0.01571179
+3386,0.002618174,0.005398626,0.01674744
+3387,0.001206789,-0.005877385,0.03604523
+3388,0.002539037,0.005436294,0.03618036
+3389,0.002814377,0.005298989,0.03706517
+3390,0.0007706098,-0.005950308,0.00954198
+3391,-0.005701495,0.001868946,0.0084042
+3392,-0.005269115,0.002869918,0.008490696
+3393,-0.00495125,0.00338897,0.009606821
+3394,-0.00585997,0.001288704,0.009496375
+3395,0.000821901,0.00594344,0.04386763
+3396,0.001778378,0.00573039,0.04358293
+3397,-0.001368781,-0.005841784,0.0332626
+3398,0.00002145661,0.005999962,0.04407144
+3399,-0.0009258107,0.005928143,0.04393516
+3400,-0.001627538,0.005775043,0.04391694
+3401,-0.002220428,0.00557402,0.04365156
+3402,-0.003845887,0.00460534,0.04359363
+3403,-0.004391734,0.004088114,0.04343171
+3404,-0.003286771,0.005019675,0.04348136
+3405,0.0003167744,-0.005991632,0.03484644
+3406,-0.0001603854,-0.005997856,0.03374412
+3407,-0.0009489504,0.005924483,0.02463435
+3408,-0.004584502,0.003870703,0.04238154
+3409,-0.005113591,0.00313866,0.04328474
+3410,-0.005537619,0.002309713,0.04341086
+3411,-0.00108853,0.005900432,0.03437901
+3412,-0.002950324,-0.005224518,0.03874569
+3413,0.001264349,-0.005865273,0.007234354
+3414,0.000299674,-0.005992512,0.007259996
+3415,-0.005868756,0.001248081,0.0433754
+3416,-0.005995281,0.0002379275,0.04320341
+3417,-0.00591847,-0.0009857557,0.04317319
+3418,-0.005672407,-0.001955454,0.04333076
+3419,-0.00508932,-0.003177864,0.04343346
+3420,-0.004568301,-0.00388981,0.04365683
+3421,-0.005932859,-0.0008950887,0.04100743
+3422,-0.005594074,-0.002169408,0.04083204
+3423,-0.004012008,-0.004461367,0.04337461
+3424,-0.002937992,-0.005231463,0.04371103
+3425,-0.002197572,-0.005583071,0.04403304
+3426,-0.003481805,-0.004886413,0.04264505
+3427,-0.002532419,-0.00543938,0.01637531
+3428,-0.005983638,-0.0004427992,0.04213343
+3429,-0.005990939,0.0003296264,0.04103764
+3430,-0.001452714,-0.005821479,0.04366977
+3431,-0.0004843903,-0.005980415,0.04327566
+3432,0.0004697588,-0.005981582,0.04311269
+3433,0.00226608,-0.005555617,0.04340005
+3434,0.00260576,0.005404629,0.02212073
+3435,0.001447772,0.00582271,0.02278422
+3436,0.002742389,0.0053366,0.01805238
+3437,0.001577954,0.005788788,0.01765587
+3438,0.0002904003,0.005992968,0.01702412
+3439,0.0004289911,0.005984644,0.01832906
+3440,0.001402449,-0.005833793,0.04294094
+3441,0.002311828,-0.005536737,0.04230887
+3442,0.002166982,-0.005595015,0.04128053
+3443,-0.005702074,0.001867176,0.04219911
+3444,-0.0001132961,-0.00599893,0.008517129
+3445,-0.005251684,-0.002901692,0.04220592
+3446,0.0009345286,-0.005926775,0.04080594
+3447,-0.0004280584,-0.005984711,0.009788773
+3448,-0.004564702,0.003894034,0.0108404
+3449,-0.001923647,-0.005683272,0.01011962
+3450,-0.003046881,-0.005168802,0.01001544
+3451,-0.001066483,-0.005904457,0.01114447
+3452,0.00199383,0.005659032,0.03757024
+3453,0.00315548,0.005103229,0.03799568
+3454,-0.005804162,0.001520428,0.04105794
+3455,0.002454302,0.005475071,0.0134907
+3456,0.002588109,0.005413104,0.01453938
+3457,-0.00128285,-0.005861254,0.01256956
+3458,0.003104987,0.005134107,0.0409441
+3459,0.002170212,0.005593762,0.04148256
+3460,-0.005755203,-0.001696359,0.01030228
+3461,-0.005960899,-0.0006838723,0.01048279
+3462,-0.003517437,0.004860827,0.01076281
+3463,0.002315269,0.005535299,0.03210612
+3464,0.002863231,0.005272751,0.03120919
+3465,0.001581054,0.005787942,0.03103003
+3466,-0.001346782,-0.005846895,0.01573558
+3467,-0.001312146,-0.005854765,0.01427896
+3468,0.002639286,0.005388337,0.02111308
+3469,0.0001797371,0.005997307,0.02232042
+3470,0.0001777413,0.005997367,0.02353669
+3471,0.002519111,0.005445556,0.02820281
+3472,0.001687043,0.005757941,0.02913324
+3473,0.002961657,0.005218102,0.02920267
+3474,-0.0004696944,-0.005981587,0.03226883
+3475,-0.000677832,-0.005961589,0.03108223
+3476,-0.00304857,-0.005167806,0.04015837
+3477,-0.00205551,-0.005636921,0.03927336
+3478,-0.001236283,-0.005871252,0.01862809
+3479,-0.001300322,-0.005857402,0.01721677
+3480,0.002975077,0.005210462,0.02726064
+3481,0.001701856,0.00575358,0.02719121
+3482,0.001454671,0.005820991,0.01517852
+3483,0.002760457,0.005327277,0.01980951
+3484,0.001580997,0.005787957,0.02026437
+3485,0.0001580083,0.005997919,0.02893828
+3486,0.0006544409,0.005964202,0.02993814
+3487,0.00004787173,0.005999809,0.03083507
+3488,0.003147232,0.00510832,0.03024007
+3489,0.0007170189,0.005957003,0.02622243
+3490,0.000205535,0.005996479,0.0271646
+3491,0.0001064087,0.005999056,0.01442258
+3492,0.00009498796,0.005999248,0.01559499
+3493,0.0003812974,0.005987872,0.01963916
+3494,0.0002457962,0.005994963,0.02094273
+3495,-0.005902713,0.001076094,0.03993193
+3496,0.002882693,0.005262137,0.0254299
+3497,0.003176528,0.005090154,0.02626917
+3498,0.002800125,0.005306534,0.01893761
+3499,-0.0001729902,-0.005997506,0.03593667
+3500,0.003124938,0.005121988,0.03993867
+3501,0.001401956,-0.005833911,0.02853822
+3502,-0.003408579,-0.004937772,0.04149733
+3503,0.003223941,0.005060257,0.03899251
+3504,0.002562622,0.005425216,0.03323822
+3505,0.002621681,0.005396924,0.03415051
+3506,0.0007749648,0.005949742,0.0376371
+3507,0.002491138,0.005458409,0.03495607
+3508,-0.0006738042,-0.005962046,0.02695135
+3509,-0.0008436183,-0.005940396,0.02558947
+3510,-0.0007841989,-0.005948532,0.0388114
+3511,-0.0006285546,-0.005966986,0.03749807
+3512,0.001820307,0.005717209,0.02512477
+3513,0.0004924723,-0.005979755,0.02897548
+3514,-0.0007757014,-0.005949646,0.02970732
+3515,-0.0006159123,-0.005968304,0.02830565
+3516,0.0003293209,0.005990955,0.02509816
+3517,0.001577675,0.005788864,0.01278402
+3518,-0.0009501558,-0.005924289,0.02420105
+3519,-0.001085385,-0.005901012,0.02284289
+3520,-0.002716603,0.005349773,0.0426987
+3521,-0.002246837,0.005563427,0.02875789
+3522,-0.002229058,0.005570574,0.03042305
+3523,-0.001092218,0.005899751,0.03135487
+3524,-0.002068761,-0.005632071,0.02494047
+3525,0.0005190809,-0.005977504,0.04202151
+3526,0.001118114,0.005894898,0.04077808
+3527,-0.001174737,-0.005883876,0.02146402
+3528,-0.001155486,-0.005887686,0.020097
+3529,-0.002254137,-0.005560474,0.02217319
+3530,-0.002608908,0.00540311,0.01057586
+3531,-0.0008459531,0.005940064,0.0279695
+3532,0.0006592619,0.005963671,0.01206767
+3533,0.0005441376,0.005975275,0.01328976
+3534,-0.000006954757,-0.005999996,0.04097769
+3535,-0.00537726,-0.00266178,0.01092598
+3536,-0.001911516,0.005687364,0.04168616
+3537,-0.0008965197,-0.005932643,0.04022408
+3538,-0.005970022,0.0005990266,0.0107259
+3539,0.005449547,0.0005478803,0.05
+3540,0.0055,-6.123234E-019,0.05
+3541,0.005262505,0.001541304,0.05
+3542,0.005399606,0.001045085,0.05
+3543,0.004891361,0.002497451,0.05
+3544,0.00510206,0.002047928,0.05
+3545,0.004344133,0.003369238,0.05
+3546,0.00462608,0.002960619,0.05
+3547,0.003640488,0.00412261,0.05
+3548,0.003985962,0.003766083,0.05
+3549,0.003217357,0.00443168,0.05
+3550,0.00234967,0.004953808,0.05
+3551,0.002814051,0.004725428,0.05
+3552,0.001398207,0.005309922,0.05
+3553,0.00187423,0.005168975,0.05
+3554,0.0003126434,0.005487067,0.05
+3555,0.0008575706,0.005424954,0.05
+3556,-0.000729482,0.005451029,0.05
+3557,-0.0002339502,0.005481234,0.05
+3558,-0.001721973,0.005223201,0.05
+3559,-0.001238208,0.005334713,0.05
+3560,-0.002202523,0.005022108,0.05
+3561,-0.003137174,0.004508271,0.05
+3562,-0.002701381,0.00478736,0.05
+3563,-0.003917466,0.003856701,0.05
+3564,-0.003550452,0.004191013,0.05
+3565,-0.004577157,0.003047946,0.05
+3566,-0.004250125,0.003469183,0.05
+3567,-0.005055994,0.002164893,0.05
+3568,-0.004819464,0.00261179,0.05
+3569,-0.005211963,0.001693578,0.05
+3570,-0.005445822,0.0006866851,0.05
+3571,-0.005368984,0.001187805,0.05
+3572,-0.00547947,-0.0003974221,0.05
+3573,-0.005492625,0.0001508758,0.05
+3574,-0.005314162,-0.001411674,0.05
+3575,-0.005411994,-0.0009249573,0.05
+3576,-0.004960009,-0.002376617,0.05
+3577,-0.005136769,-0.001912699,0.05
+3578,-0.004707395,-0.002807544,0.05
+3579,-0.004103479,-0.003640663,0.05
+3580,-0.00444799,-0.003233752,0.05
+3581,-0.003383759,-0.004325338,0.05
+3582,-0.003764603,-0.00400687,0.05
+3583,-0.002527032,-0.004880703,0.05
+3584,-0.002967463,-0.004623536,0.05
+3585,-0.001551955,-0.005276157,0.05
+3586,-0.002021115,-0.005099697,0.05
+3587,-0.0005719083,-0.005470055,0.05
+3588,-0.001059116,-0.005374699,0.05
+3589,-0.00007564599,-0.005483756,0.05
+3590,0.0009163385,-0.005413645,0.05
+3591,0.0004246117,-0.005481973,0.05
+3592,0.001961823,-0.005136544,0.05
+3593,0.001488098,-0.005285031,0.05
+3594,0.002910926,-0.004666477,0.05
+3595,0.002463681,-0.00489383,0.05
+3596,0.00332158,-0.004361104,0.05
+3597,0.004058232,-0.003695581,0.05
+3598,0.003715083,-0.004054347,0.05
+3599,0.004675759,-0.002882228,0.05
+3600,0.004382982,-0.003316792,0.05
+3601,0.005131089,-0.001973487,0.05
+3602,0.00492748,-0.002426264,0.05
+3603,0.005408899,-0.0009924769,0.05
+3604,0.005278592,-0.001496845,0.05
+3605,0.005458812,-0.0004954092,0.05
+3606,0.0055,-6.123234E-019,0
+3607,0.005449854,0.0005462238,0
+3608,0.005399913,0.001043428,0
+3609,0.005263069,0.001539785,0
+3610,0.005102623,0.00204641,0
+3611,0.004892135,0.002496103,0
+3612,0.004626854,0.002959271,0
+3613,0.004345077,0.003368087,0
+3614,0.003986906,0.003764932,0
+3615,0.003641559,0.004121673,0
+3616,0.00321852,0.004430977,0
+3617,0.002815213,0.004724726,0
+3618,0.002350875,0.00495334,0
+3619,0.001875435,0.005168507,0
+3620,0.001399408,0.005309672,0
+3621,0.0008587718,0.005424704,0
+3622,0.0003138048,0.005487041,0
+3623,-0.0002327889,0.005481208,0
+3624,-0.000728397,0.005451186,0
+3625,-0.001237123,0.00533487,0
+3626,-0.001720991,0.005223514,0
+3627,-0.002201668,0.005022557,0
+3628,-0.002700526,0.004787809,0
+3629,-0.003136461,0.00450882,0
+3630,-0.003549738,0.004191561,0
+3631,-0.003916897,0.003857312,0
+3632,-0.004249557,0.003469794,0
+3633,-0.004576741,0.003048593,0
+3634,-0.004819048,0.002612437,0
+3635,-0.005055718,0.00216554,0
+3636,-0.005211813,0.001694199,0
+3637,-0.005368835,0.001188426,0
+3638,-0.005445783,0.000687257,0
+3639,-0.005492586,0.0001514476,0
+3640,-0.005479529,-0.0003969177,0
+3641,-0.005412053,-0.0009244529,0
+3642,-0.005314285,-0.001411249,0
+3643,-0.005136892,-0.001912274,0
+3644,-0.004960172,-0.002376277,0
+3645,-0.004707574,-0.002807289,0
+3646,-0.004448169,-0.003233498,0
+3647,-0.004103654,-0.00364049,0
+3648,-0.003764778,-0.004006697,0
+3649,-0.003383907,-0.004325234,0
+3650,-0.002967611,-0.004623432,0
+3651,-0.002527156,-0.004880644,0
+3652,-0.00202124,-0.005099638,0
+3653,-0.001552003,-0.005276143,0
+3654,-0.001059164,-0.005374686,0
+3655,-0.0005718931,-0.005470056,0
+3656,-0.00007556537,-0.005483751,0
+3657,0.0004246923,-0.005481969,0
+3658,0.0009164811,-0.005413613,0
+3659,0.00148824,-0.005284999,0
+3660,0.001962019,-0.005136465,0
+3661,0.002463877,-0.00489375,0
+3662,0.002911162,-0.004666331,0
+3663,0.003321836,-0.004360877,0
+3664,0.003715339,-0.00405412,0
+3665,0.004058488,-0.003695264,0
+3666,0.004383238,-0.003316475,0
+3667,0.004675988,-0.002881814,0
+3668,0.004927709,-0.00242585,0
+3669,0.005131269,-0.001972979,0
+3670,0.005278772,-0.001496337,0
+3671,0.005408998,-0.0009918813,0
+3672,0.005458912,-0.0004948136,0
+3673,0.004974967,0.0004997062,0.0493923
+3674,0.004706148,0.001688837,0.04949755
+3675,0.004858989,0.001179079,0.04949755
+3676,0.003564153,0.003506681,0.04945522
+3677,0.003918642,0.003105518,0.04945522
+3678,0.00182673,0.004654359,0.04950504
+3679,0.00230254,0.004438278,0.04950504
+3680,-0.0003120547,0.004990253,0.04944178
+3681,0.0002353749,0.004994457,0.04944178
+3682,-0.002385881,0.004394038,0.04941522
+3683,-0.001886819,0.004630325,0.04941522
+3684,-0.003955783,0.003058069,0.04949433
+3685,-0.003622731,0.003446131,0.04949433
+3686,-0.004851895,0.00120794,0.0495126
+3687,-0.004696661,0.001715045,0.0495126
+3688,-0.004919031,-0.0008961768,0.04944121
+3689,-0.004986449,-0.0003678721,0.04944121
+3690,-0.004140656,-0.002802672,0.04949576
+3691,-0.004399663,-0.002375493,0.04949576
+3692,-0.002677791,-0.004222492,0.04952017
+3693,-0.00309616,-0.003926041,0.04952017
+3694,-0.0007206662,-0.004947791,0.04944196
+3695,-0.001214362,-0.004850291,0.04944196
+3696,0.001399929,-0.004800021,0.04952784
+3697,0.0008276728,-0.00493102,0.04952784
+3698,0.003262748,-0.00378873,0.04949791
+3699,0.002868391,-0.004095404,0.04949791
+3700,0.004518196,-0.002141474,0.04951979
+3701,0.004270546,-0.002600469,0.04951979
+3702,0.004974981,-0.0004995675,0.0493923
+3703,0.004926915,-0.0008517684,0.0006176822
+3704,0.004987364,-0.000355241,0.0006176822
+3705,0.004987364,-0.000355241,0.001206771
+3706,0.004987364,-0.000355241,0.001726873
+3707,0.004978335,-0.0004649553,0.002369701
+3708,0.004978335,-0.0004649553,0.002906449
+3709,0.00493272,-0.000817482,0.001878192
+3710,0.004978643,-0.0004616451,0.003516665
+3711,0.004978643,-0.0004616451,0.004151046
+3712,0.004914141,-0.000922614,0.003131237
+3713,0.004975486,-0.0004945059,0.004748052
+3714,0.004975486,-0.0004945059,0.005246375
+3715,0.004908577,-0.0009517755,0.004338458
+3716,0.004972245,-0.0005260974,0.005799079
+3717,0.004972245,-0.0005260974,0.00635015
+3718,0.004895836,-0.001015279,0.005488168
+3719,0.004971031,-0.0005374447,0.006919118
+3720,0.004971031,-0.0005374447,0.007472431
+3721,0.004886888,-0.001057511,0.006609839
+3722,0.004970357,-0.0005436499,0.008041971
+3723,0.004970357,-0.0005436499,0.008628818
+3724,0.004883123,-0.001074758,0.007748347
+3725,0.004970741,-0.0005401247,0.009181489
+3726,0.004970741,-0.0005401247,0.009702713
+3727,0.004882543,-0.001077391,0.008870558
+3728,0.004975557,-0.0004937935,0.01024545
+3729,0.004975557,-0.0004937935,0.01078219
+3730,0.004893099,-0.001028388,0.009965964
+3731,0.004975504,-0.0004943231,0.01136222
+3732,0.004975504,-0.0004943231,0.01199548
+3733,0.004902363,-0.0009832808,0.01108872
+3734,0.004968399,-0.0005612625,0.01254029
+3735,0.004968399,-0.0005612625,0.01303861
+3736,0.004888569,-0.001049712,0.01221356
+3737,0.004967986,-0.0005649067,0.0135807
+3738,0.004967986,-0.0005649067,0.01413177
+3739,0.004873174,-0.001119005,0.01330046
+3740,0.004970055,-0.0005463992,0.01469347
+3741,0.004970055,-0.0005463992,0.01524903
+3742,0.0048765,-0.001104424,0.01440424
+3743,0.004971743,-0.000530825,0.01582012
+3744,0.004971743,-0.000530825,0.01640473
+3745,0.004883959,-0.001070957,0.01553704
+3746,0.004970275,-0.0005443998,0.0169722
+3747,0.004970275,-0.0005443998,0.01749454
+3748,0.004884389,-0.001068992,0.0166756
+3749,0.004968091,-0.000563977,0.01805713
+3750,0.004968091,-0.000563977,0.01859388
+3751,0.00487715,-0.00110155,0.01780566
+3752,0.004966242,-0.0005800317,0.01915645
+3753,0.004966242,-0.0005800317,0.01978859
+3754,0.004869124,-0.001136499,0.01893083
+3755,0.004965489,-0.0005864477,0.0203414
+3756,0.004965489,-0.0005864477,0.02083973
+3757,0.004863933,-0.001158516,0.02004621
+3758,0.004971109,-0.0005367235,0.02137335
+3759,0.004971109,-0.0005367235,0.02192442
+3760,0.004873845,-0.001116078,0.02113265
+3761,0.004973417,-0.0005149023,0.02248385
+3762,0.004973417,-0.0005149023,0.02304165
+3763,0.004889408,-0.001045797,0.0222257
+3764,0.004974495,-0.0005043823,0.02357725
+3765,0.004974495,-0.0005043823,0.02415961
+3766,0.004896106,-0.001013976,0.02332073
+3767,0.004974173,-0.0005075413,0.02472214
+3768,0.004974173,-0.0005075413,0.0252456
+3769,0.004897601,-0.001006729,0.02441886
+3770,0.004970861,-0.0005390181,0.02579509
+3771,0.004970861,-0.0005390181,0.02633183
+3772,0.00489047,-0.001040817,0.02553086
+3773,0.004970199,-0.0005450906,0.02689784
+3774,0.004970199,-0.0005450906,0.02752886
+3775,0.004882471,-0.001077719,0.02664635
+3776,0.004970085,-0.0005461306,0.02808095
+3777,0.004970085,-0.0005461306,0.02857928
+3778,0.004880924,-0.001084705,0.02776446
+3779,0.004975393,-0.0004954478,0.02911623
+3780,0.004975393,-0.0004954478,0.0296673
+3781,0.004891509,-0.001035926,0.0288535
+3782,0.004975393,-0.0004954462,0.03023675
+3783,0.004975393,-0.0004954462,0.03079679
+3784,0.004901813,-0.0009860174,0.02995991
+3785,0.004970403,-0.000543225,0.03134307
+3786,0.004970403,-0.000543225,0.03192319
+3787,0.004892114,-0.001033065,0.03107564
+3788,0.00496873,-0.000558323,0.03247136
+3789,0.00496873,-0.000558323,0.03299594
+3790,0.004878659,-0.001094846,0.03217009
+3791,0.004972483,-0.000523846,0.03354077
+3792,0.004972483,-0.000523846,0.03407752
+3793,0.00488289,-0.00107582,0.03326308
+3794,0.004972229,-0.0005262457,0.03465549
+3795,0.004972229,-0.0005262457,0.03528539
+3796,0.004889731,-0.001044286,0.03438588
+3797,0.004965429,-0.0005869501,0.03583478
+3798,0.004965429,-0.0005869501,0.0363331
+3799,0.004876075,-0.001106297,0.03551324
+3800,0.004963922,-0.0005995626,0.03688734
+3801,0.004963922,-0.0005995626,0.03743841
+3802,0.004859219,-0.001178132,0.03661687
+3803,0.004965179,-0.0005890652,0.03800071
+3804,0.004965179,-0.0005890652,0.03856299
+3805,0.004858716,-0.001180202,0.03773341
+3806,0.004968936,-0.0005564851,0.03912243
+3807,0.004968936,-0.0005564851,0.03970031
+3808,0.00486877,-0.001138015,0.03885515
+3809,0.004974454,-0.0005047873,0.04024932
+3810,0.004974454,-0.0005047873,0.04077503
+3811,0.004887367,-0.001055293,0.0399636
+3812,0.004975172,-0.0004976623,0.04135423
+3813,0.004975172,-0.0004976623,0.0419617
+3814,0.004899509,-0.0009974004,0.04109181
+3815,0.004968779,-0.0005578859,0.04251134
+3816,0.004968779,-0.0005578859,0.04300967
+3817,0.004888578,-0.00104967,0.04222065
+3818,0.004967787,-0.0005666479,0.04356247
+3819,0.004967787,-0.0005666479,0.04411354
+3820,0.004873542,-0.001117401,0.0433231
+3821,0.00497092,-0.0005384737,0.04467962
+3822,0.00497092,-0.0005384737,0.04527977
+3823,0.00487787,-0.001098357,0.04444198
+3824,0.004974556,-0.000503777,0.04584495
+3825,0.004974556,-0.000503777,0.04638495
+3826,0.00489137,-0.001036581,0.04557323
+3827,0.004979534,-0.000451933,0.04692458
+3828,0.004979534,-0.000451933,0.04746922
+3829,0.004908659,-0.0009513482,0.04667803
+3830,0.004985448,-0.0003811868,0.04797147
+3831,0.004985448,-0.0003811868,0.04850338
+3832,0.004930588,-0.0008302443,0.04771991
+3833,0.004974967,0.0004997062,0.0005890884
+3834,0.004867761,0.001142324,0.00045932
+3835,0.004718777,0.001653223,0.00045932
+3836,0.00450499,0.002169117,0.0004695294
+3837,0.00424769,0.002637637,0.0004695294
+3838,0.004657048,0.001819864,0.0009288494
+3839,0.003938074,0.00308084,0.0004825105
+3840,0.003586112,0.003484222,0.0004825105
+3841,0.004147859,0.002792,0.0009520399
+3842,0.00319565,0.003845494,0.0004707247
+3843,0.002795962,0.004145189,0.0004707247
+3844,0.003458059,0.003611347,0.0009532352
+3845,0.002331733,0.00442301,0.0004538302
+3846,0.001857357,0.004642222,0.0004538302
+3847,0.002609264,0.004265178,0.0009245549
+3848,0.001335211,0.004818424,0.000463424
+3849,0.0007943609,0.004936496,0.000463424
+3850,0.001622558,0.004729409,0.0009172542
+3851,0.0002664728,0.004992894,0.0005064768
+3852,-0.0002809723,0.004992099,0.0005064768
+3853,0.0005687454,0.004967548,0.0009699008
+3854,-0.0008098808,0.004933973,0.0005397653
+3855,-0.00132042,0.004822498,0.0005397653
+3856,-0.0004927061,0.004975665,0.001046242
+3857,-0.001822287,0.0046561,0.0004945142
+3858,-0.002324584,0.004426772,0.0004945142
+3859,-0.001529893,0.004760192,0.00103428
+3860,-0.002771728,0.004161433,0.0005001033
+3861,-0.003190269,0.003849959,0.0005001033
+3862,-0.002487862,0.004337112,0.0009946175
+3863,-0.003572716,0.003497956,0.000534701
+3864,-0.003911323,0.003114731,0.000534701
+3865,-0.003330012,0.003729748,0.001034804
+3866,-0.004211131,0.002695622,0.0004848064
+3867,-0.004459104,0.002261944,0.0004848064
+3868,-0.004025803,0.002965284,0.001019507
+3869,-0.004671226,0.001783157,0.0004938561
+3870,-0.004833817,0.001278363,0.0004938561
+3871,-0.004551141,0.002070535,0.0009786625
+3872,-0.004941472,0.000762793,0.0005366674
+3873,-0.004994853,0.0002268132,0.0005366674
+3874,-0.004882962,0.001075491,0.001030524
+3875,-0.004990567,-0.0003069856,0.0005439035
+3876,-0.004929602,-0.0008360738,0.0005439035
+3877,-0.004999947,0.0000229587,0.001080571
+3878,-0.00481158,-0.001359667,0.0005378719
+3879,-0.004639785,-0.001863437,0.0005378719
+3880,-0.00489055,-0.00104044,0.001081775
+3881,-0.004415214,-0.002346463,0.0005183813
+3882,-0.004159026,-0.002775339,0.0005183813
+3883,-0.004558068,-0.002055241,0.001056253
+3884,-0.003863102,-0.003174341,0.00047194
+3885,-0.003527057,-0.003543991,0.00047194
+3886,-0.004041365,-0.00294404,0.0009903213
+3887,-0.003134053,-0.003895858,0.0004697157
+3888,-0.002718576,-0.004196349,0.0004697157
+3889,-0.003357641,-0.003704895,0.0009416557
+3890,-0.002272132,-0.004453921,0.0005171522
+3891,-0.001767208,-0.004677283,0.0005171522
+3892,-0.002517262,-0.004320115,0.0009868678
+3893,-0.001248561,-0.004841601,0.0005614637
+3894,-0.0007555655,-0.004942582,0.0005614637
+3895,-0.001551915,-0.004753058,0.001078616
+3896,-0.0002257982,-0.004994899,0.0005625281
+3897,0.0002750853,-0.004992427,0.0005625281
+3898,-0.000500222,-0.004974915,0.001123992
+3899,0.0008072528,-0.004934404,0.0005484162
+3900,0.001380046,-0.004805775,0.0005484162
+3901,0.000565898,-0.004967873,0.001110944
+3902,0.001875725,-0.004634831,0.0004659443
+3903,0.002380786,-0.004396801,0.0004659443
+3904,0.001598684,-0.004737532,0.00101436
+3905,0.002838643,-0.004116079,0.0004362176
+3906,0.003235213,-0.00381227,0.0004362176
+3907,0.002561368,-0.004294111,0.0009021619
+3908,0.003606703,-0.003462902,0.0004780732
+3909,0.003934259,-0.00308571,0.0004780732
+3910,0.00339842,-0.003667525,0.0009142908
+3911,0.004204524,-0.002705915,0.0004794699
+3912,0.004463517,-0.002253223,0.0004794699
+3913,0.004045535,-0.002938307,0.0009575431
+3914,0.004986091,0.0003726881,0.001995448
+3915,0.004986091,0.0003726881,0.001475345
+3916,0.004975048,0.000498896,0.004207603
+3917,0.004975048,0.000498896,0.003573223
+3918,0.004970464,0.000542671,0.006395588
+3919,0.004970464,0.000542671,0.005844517
+3920,0.004974043,0.0005088214,0.008655506
+3921,0.004974043,0.0005088214,0.00806866
+3922,0.004975297,0.0004964111,0.01081632
+3923,0.004975297,0.0004964111,0.01027957
+3924,0.004971976,0.0005286362,0.01304897
+3925,0.004971976,0.0005286362,0.01255064
+3926,0.004967579,0.0005684714,0.01528713
+3927,0.004967579,0.0005684714,0.01473158
+3928,0.004975157,0.0004978096,0.01752754
+3929,0.004975157,0.0004978096,0.01700519
+3930,0.004962518,0.0006110796,0.01976041
+3931,0.004962518,0.0006110796,0.01912827
+3932,0.004971205,0.0005358325,0.0218905
+3933,0.004971205,0.0005358325,0.02133942
+3934,0.004967249,0.0005713482,0.02421119
+3935,0.004967249,0.0005713482,0.02362882
+3936,0.00498094,0.0004361579,0.02634416
+3937,0.00498094,0.0004361579,0.02580741
+3938,0.004980144,0.0004451614,0.02857518
+3939,0.004980144,0.0004451614,0.02807686
+3940,0.00496517,0.0005891416,0.03076918
+3941,0.00496517,0.0005891416,0.03020914
+3942,0.004973559,0.0005135307,0.03303195
+3943,0.004973559,0.0005135307,0.03250737
+3944,0.004960154,0.0006299778,0.03527674
+3945,0.004960154,0.0006299778,0.03464684
+3946,0.004967269,0.0005711758,0.03743192
+3947,0.004967269,0.0005711758,0.03688085
+3948,0.00496642,0.0005785076,0.0397745
+3949,0.00496642,0.0005785076,0.03919662
+3950,0.004970078,0.0005461955,0.04196912
+3951,0.004970078,0.0005461955,0.04136165
+3952,0.00496836,0.0005616048,0.04409304
+3953,0.00496836,0.0005616048,0.04354197
+3954,0.004983512,0.0004057251,0.04637218
+3955,0.004983512,0.0004057251,0.04583218
+3956,0.004984023,0.0003993954,0.04845795
+3957,0.004984023,0.0003993954,0.04792604
+3958,0.0049525,0.0006875626,0.04888985
+3959,0.004954254,-0.0006748056,0.04893823
+3960,0.004862042,-0.001166426,0.04954593
+3961,0.004721378,-0.00164578,0.04954593
+3962,0.004888391,-0.001050541,0.04865701
+3963,0.004957555,0.0006501148,0.001048408
+3964,0.004225749,0.002672648,0.04946986
+3965,0.004486912,0.002206269,0.04946986
+3966,0.002762523,0.004167549,0.04949914
+3967,0.003164609,0.003871079,0.04949914
+3968,0.0007785618,0.004939012,0.04946695
+3969,0.001319787,0.004822672,0.04946695
+3970,0.0005218914,0.004972688,0.04890874
+3971,-0.001360937,0.004811221,0.04942067
+3972,-0.000851354,0.004926987,0.04942067
+3973,-0.003261898,0.003789462,0.04943803
+3974,-0.002849272,0.004108728,0.04943803
+3975,-0.004491886,0.002196124,0.04954058
+3976,-0.004250317,0.002633402,0.04954058
+3977,-0.004996761,0.000179944,0.04945254
+3978,-0.004948411,0.000716401,0.04945254
+3979,-0.00462081,-0.001910004,0.04946828
+3980,-0.004797663,-0.001407987,0.04946828
+3981,-0.003486744,-0.003583659,0.04952805
+3982,-0.003826949,-0.003217834,0.04952805
+3983,-0.001717119,-0.004695903,0.04945706
+3984,-0.002224402,-0.00447795,0.04945706
+3985,0.0003005448,-0.004990959,0.04945997
+3986,-0.0002003196,-0.004995986,0.04945997
+3987,0.002418791,-0.004376008,0.04953728
+3988,0.001915812,-0.004618405,0.04953728
+3989,0.003967237,-0.003043195,0.04949413
+3990,0.003643759,-0.00342389,0.04949413
+3991,0.002546569,0.004302904,0.04900417
+3992,0.004106811,0.002852035,0.04892508
+3993,0.004809539,-0.001366869,0.0007346765
+3994,0.004847117,-0.001226971,0.001352359
+3995,0.004649135,-0.001839984,0.0007346765
+3996,0.004972988,0.0005190243,0.004778594
+3997,0.004896383,0.001012635,0.004425558
+3998,0.004972988,0.0005190243,0.005276918
+3999,0.004627674,0.001893312,0.04896741
+4000,0.004895306,0.001017831,0.001345577
+4001,0.004981055,0.000434843,0.003019588
+4002,0.004981055,0.000434843,0.00248284
+4003,0.00488728,0.001055698,0.005564148
+4004,0.004970504,0.0005423036,0.007521761
+4005,0.004970504,0.0005423036,0.006968448
+4006,0.004977716,0.0004715382,0.009728974
+4007,0.004977716,0.0004715382,0.00920775
+4008,0.004968995,0.0005559605,0.01199835
+4009,0.004968995,0.0005559605,0.01136509
+4010,0.00497125,0.0005354235,0.01416652
+4011,0.00497125,0.0005354235,0.01361545
+4012,0.004969377,0.0005525313,0.01644614
+4013,0.004969377,0.0005525313,0.01586154
+4014,0.004982928,0.0004128357,0.01857621
+4015,0.004982928,0.0004128357,0.01803946
+4016,0.004978893,0.0004589343,0.0208145
+4017,0.004978893,0.0004589343,0.02031618
+4018,0.004969181,0.0005542903,0.02303749
+4019,0.004969181,0.0005542903,0.02247969
+4020,0.004971518,0.0005329243,0.02529516
+4021,0.004971518,0.0005329243,0.02477169
+4022,0.004961677,0.0006178707,0.0275292
+4023,0.004961677,0.0006178707,0.02689818
+4024,0.004970661,0.0005408611,0.02963978
+4025,0.004970661,0.0005408611,0.02908871
+4026,0.004966751,0.0005756629,0.03193504
+4027,0.004966751,0.0005756629,0.03135492
+4028,0.004981767,0.0004266119,0.03409126
+4029,0.004981767,0.0004266119,0.03355451
+4030,0.004977382,0.0004750406,0.03634258
+4031,0.004977382,0.0004750406,0.03584426
+4032,0.004965185,0.0005890111,0.03859886
+4033,0.004965185,0.0005890111,0.03803658
+4034,0.004979359,0.0004538496,0.04082135
+4035,0.004979359,0.0004538496,0.04029564
+4036,0.00497934,0.0004540585,0.04300292
+4037,0.00497934,0.0004540585,0.0425046
+4038,0.00497153,0.0005328127,0.04530348
+4039,0.00497153,0.0005328127,0.04470332
+4040,0.004979111,0.0004565667,0.04742152
+4041,0.004979111,0.0004565667,0.04687687
+4042,0.004881753,0.001080967,0.0485632
+4043,0.004647127,-0.00184505,0.04906571
+4044,0.003405965,0.003660519,0.04895436
+4045,0.001576187,0.004745064,0.04897199
+4046,-0.0005654895,0.004967919,0.04886245
+4047,-0.002628118,0.004253586,0.04885325
+4048,-0.004110407,0.002846849,0.04903491
+4049,-0.004907291,0.0009583792,0.04896514
+4050,-0.004866178,-0.001149048,0.04890949
+4051,-0.003988028,-0.003015897,0.04902381
+4052,-0.002428717,-0.004370507,0.04897723
+4053,-0.0004397036,-0.004980629,0.04890193
+4054,0.001659211,-0.004716674,0.04906512
+4055,0.003463905,-0.003605741,0.04899204
+4056,0.004882283,0.00107857,0.006704607
+4057,0.004903888,0.0009756438,0.008923508
+4058,0.004889247,0.001046546,0.01112571
+4059,0.004886778,0.001058019,0.01334556
+4060,0.004874335,0.001113938,0.01561656
+4061,0.004917066,0.0009068943,0.01782098
+4062,0.00488548,0.001063994,0.0199928
+4063,0.004881163,0.001083628,0.02218762
+4064,0.004878056,0.001097527,0.02451999
+4065,0.004888865,0.00104833,0.02665902
+4066,0.004902767,0.0009812624,0.0288219
+4067,0.004864323,0.001156877,0.03105987
+4068,0.004911606,0.0009360139,0.03331283
+4069,0.004877864,0.001098383,0.03551407
+4070,0.004865396,0.001152354,0.03776278
+4071,0.004893407,0.001026921,0.0400841
+4072,0.004899941,0.0009952799,0.04222132
+4073,0.004880224,0.001087848,0.04444518
+4074,0.004925643,0.0008590912,0.04661755
+4075,-0.003451825,0.003617306,0.04893236
+4076,-0.004609745,0.001936557,0.04905318
+4077,-0.004999278,-0.00008497132,0.04889376
+4078,-0.004523232,-0.002130815,0.04896404
+4079,-0.003279102,-0.003774584,0.04904822
+4080,-0.001467333,-0.004779847,0.04889902
+4081,0.0006117767,-0.004962432,0.04898781
+4082,0.002629359,-0.004252819,0.04903519
+4083,0.004147675,-0.002792274,0.04901392
+4084,0.004889675,0.001044547,0.01675001
+4085,0.004895118,0.001018734,0.01888497
+4086,0.004901038,0.0009898619,0.02107349
+4087,0.004873293,0.001118486,0.02336815
+4088,0.004906079,0.0009645661,0.02559275
+4089,0.004886962,0.001057166,0.0277607
+4090,0.004872306,0.001122778,0.02990478
+4091,0.004881361,0.001082734,0.03221794
+4092,0.004888315,0.001050893,0.03439097
+4093,0.004890533,0.001040523,0.03661985
+4094,0.00486369,0.001159535,0.0389652
+4095,0.004899982,0.0009950743,0.04114554
+4096,0.004896831,0.001010469,0.04329585
+4097,0.0049119,0.0009344706,0.04558417
+4098,0.00492673,0.0008528346,0.04762677
+4099,-0.001635701,0.004724879,0.04883589
+4100,0.00487814,0.001097154,0.0144771
+4101,0.004882364,0.001078202,0.01222678
+4102,0.004906307,0.0009634071,0.01002635
+4103,0.00491281,0.0009296787,0.003300932
+4104,0.004934787,0.0008049094,0.002259905
+4105,0.004889512,0.001045308,0.007824365
+4106,0.004854903,0.001195793,0.001865936
+4107,0.004780677,0.001464624,0.001439
+4108,0.004587536,0.001988597,0.001449209
+4109,0.004839612,0.001256247,0.002353328
+4110,0.004818929,-0.001333386,0.001995187
+4111,0.001368682,0.004809024,0.0483694
+4112,0.00187389,0.004635573,0.04840748
+4113,0.003988575,0.003015173,0.0482587
+4114,0.004285711,0.002575398,0.04827333
+4115,-0.0008212017,0.004932102,0.04823829
+4116,-0.0002815255,0.004992068,0.0482594
+4117,-0.002904728,0.004069712,0.04815781
+4118,-0.002445249,0.004361279,0.048135
+4119,0.004693247,0.001724364,0.01475054
+4120,0.004704611,0.001693115,0.01418549
+4121,-0.0042747,0.002593634,0.04858253
+4122,-0.00398414,0.00302103,0.04853628
+4123,-0.004937125,0.0007904395,0.04830412
+4124,-0.004833257,0.001280477,0.04836417
+4125,-0.004799173,-0.001402833,0.048296
+4126,-0.004919991,-0.0008908923,0.04826893
+4127,-0.003795414,-0.00325497,0.04849881
+4128,-0.004113151,-0.002842885,0.04846652
+4129,-0.002223926,-0.004478186,0.04833651
+4130,-0.002677342,-0.004222776,0.04839963
+4131,-0.001217369,-0.004849537,0.04825343
+4132,-0.001720031,-0.004694837,0.04826853
+4133,0.0009392587,-0.004910987,0.04844919
+4134,0.0004136252,-0.004982862,0.04838132
+4135,0.002838295,-0.004116319,0.04846632
+4136,0.002386651,-0.00439362,0.04850569
+4137,0.004313355,-0.002528828,0.04848668
+4138,0.004017478,-0.002976554,0.04846102
+4139,0.004716844,0.001658729,0.007036889
+4140,0.004716722,0.001659077,0.00646403
+4141,0.004737868,0.001597688,0.01713523
+4142,0.004719998,0.001649732,0.01657618
+4143,0.0023241,0.004427026,0.04852721
+4144,0.002782761,0.004154063,0.04852131
+4145,0.002129698,0.004523758,0.04792462
+4146,0.000292154,0.004991457,0.04830793
+4147,0.0008346753,0.004929839,0.0483331
+4148,0.001145587,0.004866994,0.04776859
+4149,0.00003408303,0.004999884,0.04768377
+4150,0.004789329,0.001436081,0.00925266
+4151,0.004778434,0.001471926,0.008700416
+4152,0.004780906,-0.001463878,0.002756733
+4153,0.004781878,-0.001460699,0.003366949
+4154,0.004796098,-0.001413309,0.003973549
+4155,0.004786663,-0.001444944,0.004570554
+4156,0.004608977,-0.001938384,0.003599045
+4157,0.004737452,-0.001598922,0.005119896
+4158,0.004727201,-0.001628979,0.0056726
+4159,0.004564331,-0.002041294,0.004754986
+4160,0.004726802,-0.001630135,0.00626682
+4161,0.004723069,-0.001640919,0.006835788
+4162,0.004495424,-0.002188873,0.005898548
+4163,0.004713515,-0.001668167,0.007447803
+4164,0.004711428,-0.001674049,0.008017343
+4165,0.004482167,-0.002215893,0.007104783
+4166,0.004696895,-0.001714402,0.008598619
+4167,0.00469811,-0.001711071,0.00915129
+4168,0.004449902,-0.002279995,0.008298075
+4169,0.004717689,-0.001656325,0.009717478
+4170,0.004732914,-0.001612303,0.01026021
+4171,0.004456835,-0.002266411,0.009445539
+4172,0.00477992,-0.001467095,0.0107833
+4173,0.004779763,-0.001467604,0.01136332
+4174,0.004548388,-0.002076576,0.01053481
+4175,0.004722921,-0.001641345,0.01187435
+4176,0.004700396,-0.00170478,0.01241916
+4177,0.00453577,-0.002103993,0.01156892
+4178,0.004666758,-0.001794817,0.01298037
+4179,0.004665441,-0.001798239,0.01352246
+4180,0.004411402,-0.002353621,0.01264117
+4181,0.004690833,-0.001730921,0.01409362
+4182,0.004697247,-0.001713438,0.01465531
+4183,0.004399974,-0.002374916,0.01377353
+4184,0.004715147,-0.001663548,0.01525273
+4185,0.004720335,-0.001648767,0.01582383
+4186,0.004457944,-0.002264229,0.01494211
+4187,0.0047216,-0.001645143,0.01639017
+4188,0.00471709,-0.001658031,0.01695764
+4189,0.004483396,-0.002213404,0.01610587
+4190,0.004704769,-0.001692675,0.017547
+4191,0.004698064,-0.001711197,0.01810959
+4192,0.004468721,-0.002242885,0.01726157
+4193,0.004667944,-0.001791731,0.01867988
+4194,0.004662128,-0.00180681,0.01924246
+4195,0.004412315,-0.002351908,0.01842123
+4196,0.004650152,-0.001837412,0.01982646
+4197,0.004647774,-0.001843419,0.02037927
+4198,0.004355171,-0.002456112,0.01957552
+4199,0.004661011,-0.001809691,0.02095442
+4200,0.004678889,-0.001762953,0.02148805
+4201,0.004356825,-0.002453176,0.02073468
+4202,0.004740672,-0.001589348,0.02198754
+4203,0.004747601,-0.001568528,0.02254697
+4204,0.004460746,-0.002258705,0.02180932
+4205,0.004714205,-0.001666216,0.0230774
+4206,0.004717718,-0.001656241,0.02361301
+4207,0.004496767,-0.002186111,0.02283925
+4208,0.004762365,-0.001523115,0.02412974
+4209,0.004761397,-0.001526139,0.02469227
+4210,0.004512898,-0.002152615,0.02388642
+4211,0.004730289,-0.00161999,0.02521791
+4212,0.004719939,-0.001649901,0.0257674
+4213,0.004530628,-0.002115044,0.0249288
+4214,0.004707925,-0.001683878,0.02636307
+4215,0.004705864,-0.001689628,0.02692908
+4216,0.004471916,-0.002236507,0.02605012
+4217,0.004691803,-0.00172829,0.0275115
+4218,0.004691441,-0.001729271,0.02806359
+4219,0.004436863,-0.002305264,0.02722822
+4220,0.004711963,-0.001672543,0.02862511
+4221,0.004728765,-0.001624433,0.02916207
+4222,0.004445677,-0.002288221,0.02837216
+4223,0.004778749,-0.001470902,0.02967494
+4224,0.00477875,-0.001470901,0.03024438
+4225,0.004542774,-0.002088829,0.02944654
+4226,0.004728207,-0.001626056,0.03075925
+4227,0.004712366,-0.001671408,0.03130553
+4228,0.004542056,-0.00209039,0.03047428
+4229,0.004689644,-0.001734139,0.03187061
+4230,0.004684354,-0.001748379,0.03241877
+4231,0.004441169,-0.002296958,0.03155422
+4232,0.004691616,-0.001728797,0.03300226
+4233,0.004703494,-0.001696214,0.03354709
+4234,0.004419927,-0.002337573,0.03270278
+4235,0.004748774,-0.001564974,0.03408028
+4236,0.004748019,-0.001567265,0.03465825
+4237,0.004492331,-0.002195213,0.03381946
+4238,0.004688971,-0.001735958,0.03517541
+4239,0.004667414,-0.001793111,0.0357248
+4240,0.00447467,-0.002230992,0.03486981
+4241,0.004645944,-0.001848028,0.0363066
+4242,0.004641234,-0.001859825,0.03686084
+4243,0.004363592,-0.00244112,0.03596877
+4244,0.004642212,-0.001857382,0.03746279
+4245,0.004646129,-0.001847562,0.03802509
+4246,0.004335812,-0.002490127,0.03715252
+4247,0.004659671,-0.001813137,0.03862279
+4248,0.004671463,-0.001782535,0.03918223
+4249,0.00435541,-0.002455688,0.03835217
+4250,0.004702758,-0.001698255,0.0397474
+4251,0.004720162,-0.001649264,0.04029641
+4252,0.004416324,-0.002344373,0.03951504
+4253,0.004773391,-0.001488199,0.0408125
+4254,0.004775518,-0.001481361,0.0413917
+4255,0.004532014,-0.002112072,0.0405963
+4256,0.004723766,-0.001638914,0.04192103
+4257,0.004703568,-0.001696009,0.04247067
+4258,0.004533617,-0.002108629,0.04164172
+4259,0.00467721,-0.001767401,0.04305353
+4260,0.004674086,-0.001775647,0.04360633
+4261,0.004426315,-0.002325453,0.0427539
+4262,0.004686825,-0.001741744,0.0442084
+4263,0.004696625,-0.001715144,0.04477448
+4264,0.004407624,-0.002360689,0.04393883
+4265,0.004728441,-0.001625375,0.04537287
+4266,0.004739667,-0.001592343,0.04593805
+4267,0.004468161,-0.002244001,0.04513929
+4268,0.00476986,-0.001499479,0.04654025
+4269,0.00478522,-0.001449713,0.04707988
+4270,0.004551385,-0.002069999,0.04633989
+4271,0.00482075,-0.00132679,0.04764423
+4272,0.004839102,-0.00125821,0.04814648
+4273,0.004756394,-0.001541661,0.04858133
+4274,0.004640123,-0.001862595,0.04750645
+4275,0.004344207,0.002475452,0.001499345
+4276,0.004051538,0.002930024,0.001512326
+4277,0.004518005,0.002141875,0.002009495
+4278,0.003697337,0.003365961,0.001531204
+4279,0.00331881,0.00373972,0.001519418
+4280,0.003937666,0.003081362,0.002078509
+4281,0.002891705,0.004078976,0.001451601
+4282,0.002434069,0.004367529,0.001434706
+4283,0.00316435,0.00387129,0.00202957
+4284,0.001919133,0.004617026,0.001402388
+4285,0.001399384,0.00480018,0.001411982
+4286,0.002226946,0.004476685,0.001929434
+4287,0.0008569346,0.004926019,0.001495511
+4288,0.0003298046,0.004989111,0.001538563
+4289,0.001167515,0.00486178,0.001980645
+4290,-0.0001928933,0.004996278,0.001646659
+4291,-0.0007227445,0.004947488,0.001679948
+4292,0.00009825961,0.004999034,0.002172269
+4293,-0.001247418,0.004841895,0.001679385
+4294,-0.001751742,0.004683097,0.001634134
+4295,-0.0009542787,0.00490809,0.002279802
+4296,-0.002216884,0.004481676,0.001493523
+4297,-0.002670312,0.004227225,0.001499112
+4298,-0.001949594,0.004604246,0.002138629
+4299,-0.003077945,0.003940337,0.001625382
+4300,-0.003470382,0.003599507,0.00165998
+4301,-0.002830214,0.004121879,0.002124288
+4302,-0.003846556,0.003194371,0.001653006
+4303,-0.004154904,0.002781505,0.001603111
+4304,-0.003628525,0.00344003,0.002243584
+4305,-0.004416218,0.002344573,0.001471141
+4306,-0.004637217,0.001869818,0.001480191
+4307,-0.004272405,0.002597413,0.00210464
+4308,-0.004796812,0.001410883,0.001606967
+4309,-0.004918613,0.00089847,0.001649778
+4310,-0.00470171,0.001701152,0.002099446
+4311,-0.004987268,0.000356586,0.001665575
+4312,-0.004996861,-0.0001771439,0.001672811
+4313,-0.004950627,0.0007009209,0.002242018
+4314,-0.004944697,-0.0007415992,0.001668834
+4315,-0.004836715,-0.001267355,0.001662802
+4316,-0.004983165,-0.0004099546,0.002253838
+4317,-0.004666428,-0.001795676,0.001650919
+4318,-0.004448914,-0.002281921,0.001631429
+4319,-0.004766841,-0.001509049,0.002237977
+4320,-0.004184691,-0.002736487,0.001616354
+4321,-0.003892496,-0.003138228,0.001569912
+4322,-0.00433195,-0.00249684,0.00221102
+4323,-0.003571057,-0.003499651,0.001434018
+4324,-0.00318248,-0.0038564,0.001431794
+4325,-0.003743001,-0.003315108,0.002060051
+4326,-0.002792605,-0.004147452,0.00152727
+4327,-0.002350801,-0.004412905,0.001574707
+4328,-0.003033207,-0.003974878,0.002019633
+4329,-0.001837033,-0.004650302,0.001640303
+4330,-0.001320904,-0.004822366,0.001684615
+4331,-0.002135264,-0.004521134,0.002180706
+4332,-0.0007715549,-0.004940112,0.001759949
+4333,-0.0002419597,-0.004994142,0.001761014
+4334,-0.001069439,-0.004884291,0.002321636
+4335,0.000325912,-0.004989367,0.001757422
+4336,0.0008574611,-0.004925927,0.00174331
+4337,0.0000525522,-0.004999724,0.00239338
+4338,0.00140591,-0.004798272,0.001684399
+4339,0.001900661,-0.004624661,0.001601927
+4340,0.001173119,-0.004860431,0.002330877
+4341,0.00232989,-0.004423982,0.001388818
+4342,0.002790956,-0.004148562,0.001359092
+4343,0.00214919,-0.00451453,0.002058857
+4344,0.003180508,-0.003858027,0.001383501
+4345,0.003556944,-0.003513993,0.001425356
+4346,0.002971298,-0.004021366,0.001870157
+4347,0.003907213,-0.003119886,0.001641773
+4348,0.004180778,-0.002742462,0.00164317
+4349,0.003720136,-0.003340746,0.002110983
+4350,0.00472067,0.00164781,0.008200727
+4351,0.004709467,0.00167956,0.007653829
+4352,0.004472739,0.002234862,0.007413251
+4353,0.004543222,0.002087854,0.00852988
+4354,0.00474729,0.001569469,0.004640445
+4355,0.004753603,0.001550245,0.004069454
+4356,0.004514623,-0.002148994,0.001214146
+4357,0.004641799,-0.001858414,0.002230899
+4358,0.004719442,0.001651324,0.005816303
+4359,0.004727242,0.001628859,0.005248704
+4360,0.00451706,0.002143868,0.004892599
+4361,0.004486207,0.002207701,0.006148585
+4362,0.004548707,0.002075878,0.04839317
+4363,0.004752921,0.001552335,0.04842086
+4364,0.004461382,0.002257449,0.04772678
+4365,0.004696808,0.00171464,0.0113475
+4366,0.004717006,0.001658268,0.01079873
+4367,0.004793576,0.00142184,0.003475485
+4368,0.004811474,0.001360045,0.00292185
+4369,0.004687722,0.001739329,0.00252788
+4370,0.004598068,0.001964121,0.003690371
+4371,0.004741913,0.001585644,0.01361838
+4372,0.004744073,0.001579168,0.0130519
+4373,0.004494437,0.002190898,0.01389182
+4374,0.004783764,0.001454511,0.01027394
+4375,0.004790974,0.001430583,0.009723349
+4376,0.004619597,0.001912936,0.009500257
+4377,0.004535754,0.002104029,0.01049573
+4378,0.004699361,0.001707631,0.01595379
+4379,0.004693858,0.001722699,0.01537939
+4380,0.004444242,0.002291007,0.01508778
+4381,0.004472863,0.002234613,0.01633901
+4382,0.004697221,0.001713509,0.01250827
+4383,0.00468773,0.001739305,0.01195597
+4384,0.004481868,0.002216497,0.01278109
+4385,0.004812497,0.001356419,0.01829686
+4386,0.004788649,0.001438347,0.01778494
+4387,0.004570366,0.002027746,0.01761111
+4388,0.00475462,0.001547121,0.01884892
+4389,0.004755427,0.001544642,0.02058547
+4390,0.004705932,0.00168944,0.0200297
+4391,0.004730985,0.001617956,0.02111039
+4392,0.004719897,0.001650021,0.02244808
+4393,0.004725992,0.001632481,0.02185888
+4394,0.004691161,0.001730031,0.02491269
+4395,0.004677644,0.001766251,0.02435218
+4396,0.004786427,0.001445723,0.026084
+4397,0.004757412,0.001538516,0.02557174
+4398,0.004496754,0.002186139,0.02540394
+4399,0.004730404,0.001619654,0.02663802
+4400,0.004779115,0.001469713,0.02834804
+4401,0.004725183,0.001634822,0.02780038
+4402,0.004749965,0.001561357,0.02886157
+4403,0.004679751,0.001760663,0.03008656
+4404,0.00469664,0.001715101,0.0295172
+4405,0.004720233,0.001649062,0.03257457
+4406,0.00469925,0.001707938,0.03200224
+4407,0.004800411,0.00139859,0.03377338
+4408,0.004775259,0.001482194,0.03325081
+4409,0.004542133,0.002090221,0.03303512
+4410,0.004739202,0.001593726,0.03432895
+4411,0.004740457,0.001589991,0.03612469
+4412,0.004688585,0.001737,0.03555717
+4413,0.004708833,0.001681337,0.03666295
+4414,0.004688793,0.00173644,0.03807046
+4415,0.004694999,0.00171959,0.03746579
+4416,0.004752388,0.001553965,0.04070998
+4417,0.004711947,0.001672589,0.04018883
+4418,0.004722726,0.001641909,0.04125028
+4419,0.004754219,0.001548356,0.04275433
+4420,0.004724728,0.001636136,0.04221885
+4421,0.004719632,0.001650779,0.04329338
+4422,0.004717279,0.001657492,0.04482025
+4423,0.004707598,0.001684792,0.04420997
+4424,0.004790826,0.001431077,0.04672271
+4425,0.004805183,0.001382107,0.04621802
+4426,-0.003698103,0.003365121,0.04831578
+4427,-0.003344956,0.003716352,0.04825948
+4428,-0.003184239,0.003854948,0.04754122
+4429,-0.00389442,0.00313584,0.0478634
+4430,-0.001911723,0.004620099,0.04814155
+4431,-0.001386823,0.004803824,0.048147
+4432,-0.001110874,0.004875034,0.04754395
+4433,-0.002214247,0.00448298,0.04744611
+4434,0.004834895,0.001274281,0.04798896
+4435,0.003196911,0.003844446,0.04837526
+4436,0.00359339,0.003476715,0.04833135
+4437,0.003814542,0.003232532,0.04767959
+4438,0.002996948,0.004002287,0.0478983
+4439,0.00456415,-0.002041698,0.04855518
+4440,0.004411837,-0.002352805,0.001898376
+4441,0.004819953,0.001329683,0.04748443
+4442,-0.004697308,0.00171327,0.04856644
+4443,-0.004492715,0.002194427,0.04859442
+4444,-0.004989997,-0.0003161183,0.04823177
+4445,-0.004994625,0.0002317753,0.0482431
+4446,-0.004398666,-0.002377338,0.04842085
+4447,-0.004620008,-0.001911942,0.04839338
+4448,-0.003072899,-0.003944273,0.04856806
+4449,-0.003465501,-0.003604206,0.04857594
+4450,-0.001988594,-0.004587537,0.04769093
+4451,-0.0001226364,-0.004998496,0.04827404
+4452,-0.0006436693,-0.004958396,0.04825603
+4453,0.001928815,-0.00461299,0.04861179
+4454,0.001413445,-0.004796058,0.04860235
+4455,0.001221284,-0.004848553,0.04799585
+4456,0.002156596,-0.004510997,0.04804292
+4457,0.003652976,-0.003414054,0.04843931
+4458,0.003272951,-0.00377992,0.04844309
+4459,0.004429244,0.002319869,0.01162899
+4460,0.004467392,-0.002245532,0.04800229
+4461,-0.004714385,-0.001665705,0.04775281
+4462,0.004346255,-0.002471855,0.002659922
+4463,0.00464966,0.001838659,0.0470849
+4464,-0.004968402,0.0005612304,0.04764213
+4465,-0.002887138,-0.00408221,0.04792734
+4466,-0.00439416,0.002385657,0.04809579
+4467,-0.004966532,-0.000577549,0.04761827
+4468,0.004571124,0.002026037,0.03487083
+4469,0.004414136,0.002348489,0.03425323
+4470,0.004340735,0.002481537,0.03548144
+4471,0.004565617,0.002038416,0.02723226
+4472,0.004383074,0.002405965,0.02665724
+4473,0.004375332,0.002420014,0.0278196
+4474,0.004586609,0.001990733,0.0193984
+4475,0.004437193,0.00230463,0.01881029
+4476,0.004365861,0.002437058,0.01999107
+4477,0.004500179,0.00217908,0.02904335
+4478,0.004507937,0.002162986,0.02137086
+4479,0.004698133,0.001711007,0.0231324
+4480,0.004472703,0.002234933,0.02280367
+4481,0.004692231,0.001727127,0.02372373
+4482,0.004424084,0.002329695,0.02411644
+4483,0.004468958,0.002242412,0.03697062
+4484,0.004666379,0.001795804,0.03076541
+4485,0.004409281,0.002357592,0.03037783
+4486,0.004671236,0.001783131,0.03135115
+4487,0.004429228,0.002319901,0.03170778
+4488,0.004504316,0.002170516,0.04178329
+4489,0.004670238,0.001785743,0.03880311
+4490,0.004426313,0.002325457,0.03850612
+4491,0.004674005,0.00177586,0.03940086
+4492,0.004452692,0.002274541,0.04002674
+4493,0.004491225,0.002197475,0.04366845
+4494,0.004768334,0.001504324,0.04568932
+4495,-0.004244468,-0.002642818,0.04789586
+4496,0.003055757,-0.003957568,0.04791359
+4497,0.003858297,-0.003180179,0.04791207
+4498,-0.0009070553,-0.004917037,0.04762554
+4499,-0.004753013,0.001552053,0.04790541
+4500,-0.003616217,-0.003452966,0.04801865
+4501,0.0002088494,-0.004995636,0.04773541
+4502,0.004544912,0.002084173,0.0454541
+4503,0.004303502,0.002545558,0.01808664
+4504,0.004215965,0.002688055,0.01743693
+4505,0.004042904,0.002941926,0.01863611
+4506,0.0006889824,-0.004952303,0.04706614
+4507,0.0001544099,-0.004997615,0.04695887
+4508,-0.003284051,-0.003770279,0.04739891
+4509,-0.003630741,-0.003437691,0.04732179
+4510,0.003982393,-0.003023334,0.003189907
+4511,0.004287921,-0.002571718,0.00352243
+4512,-0.004509531,0.002159661,0.04743099
+4513,-0.004294605,0.00256054,0.0474191
+4514,0.004233986,0.00265958,0.0461394
+4515,0.00414591,0.002794894,0.04527033
+4516,0.003944691,0.003072363,0.01185133
+4517,0.003960786,0.003051585,0.01124285
+4518,0.004412762,0.002351071,0.04696506
+4519,0.004143207,-0.002798899,0.005503702
+4520,0.004142522,-0.002799912,0.006097922
+4521,0.004188208,-0.002731102,0.00674528
+4522,0.004172366,-0.002755242,0.007357295
+4523,0.00376284,-0.003292573,0.006350434
+4524,0.004061099,-0.002916758,0.00798367
+4525,0.00403593,-0.002951487,0.008564946
+4526,0.003687103,-0.003377169,0.007624166
+4527,0.00404083,-0.002944774,0.009266325
+4528,0.004074799,-0.002897588,0.009832513
+4529,0.003557662,-0.003513266,0.00895192
+4530,0.004208532,-0.002699677,0.01050219
+4531,0.00428897,-0.002569968,0.01102528
+4532,0.003726935,-0.00333316,0.01032298
+4533,0.00419216,-0.002725032,0.01153631
+4534,0.004010878,-0.002985441,0.0121758
+4535,0.003952751,-0.003061987,0.01273702
+4536,0.003674169,-0.003391236,0.01163216
+4537,0.003872362,-0.003163039,0.01346187
+4538,0.003917475,-0.003106991,0.01403303
+4539,0.003357109,-0.003705377,0.01299651
+4540,0.004126364,-0.002823671,0.01464689
+4541,0.004156065,-0.002779771,0.01524431
+4542,0.003518936,-0.003552055,0.01433523
+4543,0.00410964,-0.002847956,0.01582207
+4544,0.004111825,-0.002844801,0.01638841
+4545,0.003705245,-0.003357255,0.01552685
+4546,0.004163293,-0.002768933,0.01696012
+4547,0.004142819,-0.002799474,0.01754948
+4548,0.003711409,-0.003350439,0.01667632
+4549,0.004013554,-0.002981842,0.01810193
+4550,0.003961685,-0.003050418,0.01867222
+4551,0.003621762,-0.003447149,0.01780048
+4552,0.003910291,-0.003116027,0.01934304
+4553,0.003889727,-0.00314166,0.01992705
+4554,0.003403492,-0.003662819,0.01902375
+4555,0.003889403,-0.00314206,0.02065007
+4556,0.00391207,-0.003113794,0.02122522
+4557,0.003341585,-0.003719383,0.02041759
+4558,0.004004287,-0.002994276,0.02199897
+4559,0.0041119,-0.002844693,0.02249846
+4560,0.003451972,-0.003617166,0.02191436
+4561,0.004052291,-0.002928983,0.0230289
+4562,0.004094935,-0.00286906,0.02388769
+4563,0.004173883,-0.002752944,0.02440443
+4564,0.003610858,-0.00345857,0.02354691
+4565,0.004118632,-0.002834937,0.02493008
+4566,0.004173779,-0.002753102,0.0256737
+4567,0.004153827,-0.002783113,0.02626938
+4568,0.003727828,-0.003332161,0.02514933
+4569,0.004042791,-0.002942081,0.02692945
+4570,0.004018448,-0.002975244,0.02751187
+4571,0.003663689,-0.003402556,0.02655303
+4572,0.004013134,-0.002982407,0.02822435
+4573,0.004048825,-0.002933772,0.02878587
+4574,0.00352268,-0.003548342,0.02792558
+4575,0.004199556,-0.002713619,0.02944363
+4576,0.004284985,-0.002576608,0.0299565
+4577,0.003700952,-0.003361987,0.02929583
+4578,0.004198623,-0.002715062,0.03047136
+4579,0.00404794,-0.002934993,0.03112747
+4580,0.004008416,-0.002988745,0.03169255
+4581,0.003701094,-0.003361831,0.03060969
+4582,0.004016665,-0.002977651,0.03241587
+4583,0.004029067,-0.002960847,0.03299935
+4584,0.003526458,-0.003544586,0.03198912
+4585,0.00407279,-0.002900411,0.03376164
+4586,0.004151746,-0.002786217,0.03429483
+4587,0.003588586,-0.003481674,0.03347473
+4588,0.004049515,-0.00293282,0.03481199
+4589,0.003922848,-0.003100204,0.03552901
+4590,0.003886015,-0.003146249,0.03611081
+4591,0.003493048,-0.003577515,0.03495403
+4592,0.003880141,-0.003153491,0.03680931
+4593,0.003881801,-0.003151448,0.03741127
+4594,0.003332868,-0.003727197,0.03636956
+4595,0.003910873,-0.003115296,0.03812211
+4596,0.003933814,-0.003086277,0.03871981
+4597,0.003360407,-0.003702386,0.03777891
+4598,0.003969136,-0.003040717,0.03942075
+4599,0.004023166,-0.002968861,0.03998592
+4600,0.003436714,-0.003631666,0.0391907
+4601,0.004185254,-0.002735626,0.04062818
+4602,0.004275642,-0.002592081,0.04114427
+4603,0.003676696,-0.003388497,0.04053389
+4604,0.004187331,-0.002732446,0.04167359
+4605,0.004030893,-0.002958362,0.04235614
+4606,0.003985399,-0.00301937,0.042939
+4607,0.00368295,-0.003381697,0.04185869
+4608,0.003969977,-0.003039619,0.04367568
+4609,0.00399189,-0.003010783,0.04427774
+4610,0.003473341,-0.003596651,0.04327791
+4611,0.004090701,-0.002875094,0.04497528
+4612,0.004144721,-0.002796656,0.04557367
+4613,0.003574357,-0.00349628,0.04471213
+4614,0.00426086,-0.002616308,0.04622473
+4615,0.004311142,-0.002532599,0.04682694
+4616,0.003831035,-0.003212969,0.04606072
+4617,0.004408468,-0.002359112,0.04743794
+4618,0.004111129,0.002845807,0.01329153
+4619,0.004028495,0.002961626,0.0127479
+4620,0.003378465,0.003685916,0.00273561
+4621,0.002956866,0.00403199,0.002667793
+4622,0.00250713,0.004326003,0.002463507
+4623,0.00199646,0.004584119,0.002431189
+4624,0.002748045,0.00417711,0.003169548
+4625,0.001504509,0.004768276,0.002470259
+4626,0.0009649553,0.004906003,0.002553788
+4627,0.001804698,0.004662946,0.003004332
+4628,0.0004815222,0.00497676,0.002841445
+4629,-0.00004071539,0.004999834,0.002949541
+4630,0.0008282311,0.004930926,0.00333106
+4631,-0.0006801622,0.004953522,0.003061551
+4632,-0.001205725,0.004852446,0.003060988
+4633,-0.0002980971,0.004991106,0.003730727
+4634,-0.001891808,0.004628289,0.002891289
+4635,-0.002350683,0.004412969,0.002750679
+4636,-0.001631787,0.004726232,0.003673038
+4637,-0.002778398,0.004156983,0.002876948
+4638,-0.003394991,0.003670699,0.002918551
+4639,-0.003779486,0.003273452,0.002911577
+4640,-0.002962445,0.004027893,0.003544942
+4641,-0.004234511,0.002658744,0.002854415
+4642,-0.004482928,0.002214353,0.002722445
+4643,-0.004050934,0.002930858,0.003529382
+4644,-0.004676694,0.001768767,0.002849221
+4645,-0.00487276,0.001120807,0.002935283
+4646,-0.004965942,0.0005825982,0.002951079
+4647,-0.004717565,0.001656676,0.003558282
+4648,-0.004999557,-0.00006655612,0.002907288
+4649,-0.004959893,-0.0006320273,0.00290331
+4650,-0.004987001,0.0003603048,0.003600552
+4651,-0.004837305,-0.001265103,0.002922636
+4652,-0.004667263,-0.001793504,0.002910753
+4653,-0.004912804,-0.0009297059,0.003576086
+4654,-0.00440859,-0.002358883,0.002959721
+4655,-0.004136509,-0.002808789,0.002944646
+4656,-0.00452266,-0.002132028,0.003644379
+4657,-0.003749228,-0.003308064,0.002800808
+4658,-0.003412049,-0.003654849,0.002664914
+4659,-0.003851761,-0.003188093,0.003549509
+4660,-0.003040676,-0.003969167,0.00276039
+4661,-0.002504165,-0.00432772,0.002718899
+4662,-0.001999042,-0.004582994,0.002784495
+4663,-0.002920563,-0.004058363,0.003364179
+4664,-0.001445005,-0.004786644,0.003049777
+4665,-0.0008988806,-0.004918538,0.003125112
+4666,-0.001838402,-0.004649761,0.003587971
+4667,-0.0002077957,-0.00499568,0.003237952
+4668,0.0003600301,-0.004987021,0.003234361
+4669,-0.0005945951,-0.00496452,0.003966093
+4670,0.001065342,-0.004885187,0.003094636
+4671,0.001607891,-0.004734415,0.003035725
+4672,0.000809583,-0.004934022,0.003939209
+4673,0.002330026,-0.00442391,0.002730686
+4674,0.002738323,-0.00418349,0.002517577
+4675,0.002231619,-0.004474358,0.003494445
+4676,0.004045321,0.002938601,0.01385864
+4677,-0.004976918,0.0004798802,0.04682998
+4678,-0.004891706,0.001034994,0.046891
+4679,0.00405538,0.002924704,0.02917556
+4680,0.004148406,0.002791187,0.02851993
+4681,0.004093464,0.002871159,0.03743613
+4682,0.004116686,0.002837763,0.03663329
+4683,0.003842925,0.003198738,0.02447301
+4684,0.003869504,0.003166534,0.02384456
+4685,0.004143502,0.002798462,0.02594422
+4686,0.0040267,0.002964066,0.02528517
+4687,0.003875103,0.00315968,0.02653847
+4688,0.004075402,0.002896739,0.04237235
+4689,0.00407186,0.002901717,0.04140377
+4690,0.004181928,0.002740708,0.02181469
+4691,0.004190327,0.002727849,0.0210662
+4692,0.004033029,0.002955449,0.03210763
+4693,0.00398508,0.00301979,0.03145654
+4694,0.004250228,0.002633545,0.0335006
+4695,0.004155072,0.002781254,0.03282436
+4696,0.003987897,0.00301607,0.03404248
+4697,0.004076689,0.002894928,0.04419761
+4698,0.004097472,0.002865436,0.04328103
+4699,0.003663942,0.003402283,0.04488291
+4700,0.003892959,0.003137654,0.0306636
+4701,0.003916443,0.003108291,0.02998475
+4702,0.003439615,0.003628919,0.02946133
+4703,0.003380631,0.003683929,0.03106345
+4704,0.004043988,0.002940435,0.04050625
+4705,0.003978311,0.003028703,0.03971828
+4706,0.003492213,0.003578331,0.04109531
+4707,0.003958263,0.003054857,0.03889863
+4708,0.003990228,0.003012985,0.03816598
+4709,0.003536182,0.003534886,0.03782865
+4710,0.003434034,0.0036342,0.03937815
+4711,-0.004019543,-0.002973764,0.0473757
+4712,-0.004319891,-0.002517646,0.04733004
+4713,-0.003729655,-0.003330116,0.04675597
+4714,0.004470894,0.002238551,0.002578016
+4715,0.002150289,0.004514007,0.04726467
+4716,0.002587089,0.004278665,0.04738441
+4717,0.004105607,0.002853768,0.02313107
+4718,0.00414222,0.00280036,0.02244675
+4719,0.003745247,0.00331257,0.02214209
+4720,0.003422431,0.003645129,0.02348764
+4721,-0.004582839,-0.001999397,0.04708954
+4722,-0.004771646,-0.001493784,0.04699216
+4723,-0.004408281,-0.002359461,0.04656938
+4724,-0.004686711,0.00174205,0.04722873
+4725,-0.004714581,0.00166515,0.04641657
+4726,0.003972152,0.003036776,0.04678128
+4727,0.004083329,-0.002885555,0.04732278
+4728,0.004127879,0.002821455,0.01675528
+4729,0.004092882,0.002871988,0.01613289
+4730,0.003771703,0.003282416,0.01723081
+4731,0.004001476,0.002998031,0.0153558
+4732,0.004000413,0.00299945,0.01472695
+4733,0.003557166,0.003513769,0.01577206
+4734,0.001281908,-0.004832878,0.04736974
+4735,0.001229178,-0.004846558,0.04659319
+4736,0.00174685,-0.004684924,0.0475229
+4737,0.004391269,0.002390973,0.003227346
+4738,0.004165803,0.002765155,0.00270896
+4739,0.003829374,0.003214949,0.002727839
+4740,0.004325377,0.002508209,0.003821315
+4741,-0.001324661,0.004821335,0.04669928
+4742,-0.0007574306,0.004942297,0.04679057
+4743,-0.002904321,-0.004070003,0.04723048
+4744,0.003553245,0.003517733,0.04290151
+4745,0.003524576,-0.003546458,0.002758403
+4746,0.003441608,-0.003627029,0.003620911
+4747,-0.001816659,-0.004658299,0.04689917
+4748,-0.002315971,-0.004431284,0.04696716
+4749,0.003655412,0.003411446,0.003366062
+4750,0.003728747,-0.003331133,0.04730107
+4751,-0.000542249,-0.00497051,0.04682952
+4752,-0.001118053,-0.004873393,0.04682693
+4753,-0.00006104468,-0.004999627,0.04616025
+4754,-0.0001894422,0.00499641,0.04705104
+4755,0.0003841285,0.004985223,0.04709957
+4756,-0.0004094747,0.004983205,0.04620637
+4757,0.00409633,0.002867068,0.00516732
+4758,0.00413195,0.002815491,0.004559061
+4759,0.00101757,0.00489536,0.04704512
+4760,0.00154671,0.004754754,0.04708141
+4761,0.002031182,0.00456884,0.0465412
+4762,0.0007977337,0.004935952,0.04641239
+4763,0.004229148,-0.002667266,0.004678371
+4764,0.003811553,-0.003236057,0.004877745
+4765,0.003500437,0.003570286,0.01412666
+4766,0.004246184,0.002640061,0.009279836
+4767,0.004145541,0.002795442,0.008780147
+4768,0.003981722,0.003024217,0.03599504
+4769,0.003785355,0.003266663,0.0353087
+4770,0.003497252,0.003573406,0.03646055
+4771,-0.004048493,0.00293423,0.0471986
+4772,0.003846577,0.003194346,0.004096036
+4773,-0.004993055,-0.0002634342,0.04681382
+4774,-0.004995311,0.0002164915,0.04606269
+4775,-0.00492912,-0.0008389151,0.04685098
+4776,0.003454994,0.00361428,0.01236177
+4777,0.004032971,0.002955528,0.007886481
+4778,0.004045994,0.002937674,0.007269541
+4779,0.003631348,0.00343705,0.008636436
+4780,0.003574468,0.003496166,0.04685393
+4781,0.003015154,0.00398859,0.04723835
+4782,0.003211764,0.003832046,0.04634004
+4783,0.003890737,0.003140409,0.02795181
+4784,0.004004422,0.002994095,0.020521
+4785,0.00380206,0.003247205,0.0198897
+4786,0.003572822,0.003497848,0.02096483
+4787,-0.004856294,-0.001190129,0.04618771
+4788,0.003353402,0.003708732,0.02501329
+4789,0.00363847,0.00342951,0.03257312
+4790,-0.003576862,0.003493717,0.04681214
+4791,-0.003160252,0.003874637,0.04671047
+4792,-0.004030204,0.0029593,0.04636785
+4793,0.00431316,-0.002529161,0.00412903
+4794,-0.001468446,-0.004779505,0.04610316
+4795,-0.002750994,-0.004175169,0.04643873
+4796,-0.004996178,-0.0001954712,0.04509924
+4797,-0.004969928,0.0005475548,0.0451154
+4798,0.004249211,0.002635186,0.009750524
+4799,-0.002575096,-0.004285893,0.04535247
+4800,-0.003140947,-0.003890302,0.0456158
+4801,0.003219997,-0.00382513,0.04724544
+4802,0.002780698,-0.004155444,0.04726867
+4803,0.003398203,0.003667726,0.004103807
+4804,0.002817548,0.004130548,0.04344848
+4805,0.002785826,0.004152009,0.0425398
+4806,0.00266497,0.004230595,0.01463887
+4807,0.002728652,0.004189804,0.01377056
+4808,0.002863341,-0.004098937,0.008588943
+4809,0.00287015,-0.004094171,0.009290323
+4810,0.002913845,-0.004063189,0.01020807
+4811,0.003104569,-0.003919394,0.01087775
+4812,0.002130656,-0.004523307,0.009845096
+4813,0.002657032,-0.004235585,0.0124368
+4814,0.002546769,-0.004302786,0.01316165
+4815,0.001939774,-0.004608392,0.01473978
+4816,0.002868194,-0.004095542,0.01452832
+4817,0.002387335,-0.004393248,0.01393282
+4818,0.001581866,-0.004743174,0.01337311
+4819,0.003074014,-0.003943404,0.01714375
+4820,0.002894689,-0.004076858,0.0176962
+4821,0.002524161,-0.004316088,0.02172525
+4822,0.002653306,-0.00423792,0.022499
+4823,0.003076556,-0.003941422,0.02517172
+4824,0.003153742,-0.003879937,0.02591535
+4825,0.002857062,-0.004103315,0.02924172
+4826,0.003071877,-0.003945069,0.02989947
+4827,0.00294272,-0.004042326,0.03300504
+4828,0.003002698,-0.003997975,0.03376733
+4829,0.002423615,-0.004373338,0.03600144
+4830,0.002415455,-0.004377851,0.03669995
+4831,0.002648002,-0.004241236,0.03746365
+4832,0.00268724,-0.004216485,0.0381745
+4833,0.001641831,-0.004722752,0.03709554
+4834,0.003067732,-0.003948293,0.04123916
+4835,0.002846189,-0.004110865,0.04192171
+4836,0.00274134,-0.004181514,0.04288234
+4837,0.002720017,-0.004195415,0.04361902
+4838,0.002005974,-0.004579964,0.04226281
+4839,0.00281987,-0.004128963,0.04460395
+4840,0.002956874,-0.004031984,0.04530148
+4841,0.002000029,-0.004582563,0.04420837
+4842,0.002543711,-0.004304595,0.04589691
+4843,0.003337972,-0.003722625,0.04600509
+4844,0.002751831,0.004174617,0.04156492
+4845,0.002711875,0.004200683,0.0406674
+4846,0.001905614,0.004622622,0.04211188
+4847,0.003131514,-0.003897899,0.002541986
+4848,-0.002536861,0.004308635,0.04661438
+4849,-0.002008923,0.004578671,0.04662093
+4850,0.004134834,0.002811254,0.006508318
+4851,0.004139448,0.002804455,0.005860591
+4852,0.002659114,0.004234278,0.02573416
+4853,0.002402081,0.004385203,0.024922
+4854,0.004132326,0.002814939,0.01027531
+4855,0.003564267,0.003506565,0.01049765
+4856,0.003285015,-0.00376944,0.004513363
+4857,0.003164892,-0.003870848,0.005338694
+4858,0.002730456,-0.004188629,0.004081859
+4859,0.003584847,0.003485523,0.03457858
+4860,0.003347998,0.003713612,0.03382595
+4861,0.003101857,0.003921541,0.03509218
+4862,-0.002981511,0.0040138,0.0458853
+4863,0.003119136,0.003907811,0.04549684
+4864,0.003023144,0.003982537,0.04442413
+4865,0.002503698,0.00432799,0.04588126
+4866,0.003388755,0.003676457,0.02730815
+4867,0.003036668,0.003972234,0.02659514
+4868,0.002032882,0.004568084,0.02650384
+4869,0.003056345,0.003957114,0.02800848
+4870,0.003067062,0.003948814,0.03306759
+4871,0.002896348,0.00407568,0.03235086
+4872,0.00255586,0.004297392,0.0336037
+4873,0.003631626,0.003436756,0.01922107
+4874,0.003436794,0.00363159,0.01849742
+4875,0.003144189,0.003887682,0.019751
+4876,0.003602906,0.003466853,0.006981547
+4877,0.002400102,-0.004386287,0.04674866
+4878,0.002212918,-0.004483636,0.0474168
+4879,-0.001674467,0.00471128,0.04586756
+4880,-0.003377243,0.003687035,0.04498515
+4881,-0.002779766,0.004156068,0.04488905
+4882,0.003656886,0.003409865,0.005527053
+4883,0.002636069,0.004248663,0.01285309
+4884,0.002517059,0.004320233,0.01195651
+4885,0.001676546,0.004710541,0.0133653
+4886,0.003122152,-0.003905402,0.006300972
+4887,0.003186238,-0.003853296,0.00694833
+4888,0.002503307,-0.004328216,0.00593659
+4889,-0.001882631,0.00463203,0.04489542
+4890,-0.001191973,0.004855842,0.04497377
+4891,-0.002347524,0.00441465,0.04399527
+4892,-0.004879449,-0.001091321,0.04522378
+4893,-0.004941121,-0.0007650642,0.04427649
+4894,-0.004688502,-0.001737225,0.04536495
+4895,-0.00108601,-0.004880633,0.04509894
+4896,-0.001786014,-0.004670134,0.04517119
+4897,0.002849435,0.004108616,0.004710769
+4898,0.002607066,0.004266521,0.003980795
+4899,0.002304169,0.004437432,0.02977062
+4900,0.002506001,0.004326657,0.02896143
+4901,0.00217414,0.004502567,0.04406242
+4902,0.0005186723,-0.004973025,0.04533085
+4903,-0.0001781073,-0.004996827,0.04520151
+4904,-0.0005131769,-0.004973595,0.04426954
+4905,0.001958448,-0.004600487,0.04604504
+4906,0.001388633,-0.004803301,0.04574145
+4907,-0.0002645376,0.004992997,0.04525304
+4908,0.0003060178,0.004990627,0.0455135
+4909,-0.0004866477,0.004976261,0.0442809
+4910,0.001655685,0.004717913,0.01146565
+4911,0.002592346,0.004275481,0.01097432
+4912,0.002832177,0.004120531,0.0371887
+4913,0.002639537,0.004246509,0.03655044
+4914,0.003256042,0.003794495,0.01772925
+4915,0.003133077,0.003896643,0.0170476
+4916,0.002741792,0.004181217,0.01831421
+4917,0.003032665,-0.003975292,0.007574705
+4918,0.002270825,-0.004454588,0.007913107
+4919,0.002849723,-0.004108416,0.01151725
+4920,0.001968928,-0.004596012,0.01168239
+4921,0.003149235,-0.003883596,0.01514218
+4922,0.003084737,-0.003935022,0.01571994
+4923,0.003001195,-0.003999103,0.01657204
+4924,0.002355445,-0.004410428,0.01618737
+4925,0.002709965,-0.004201915,0.01856011
+4926,0.002639552,-0.0042465,0.01923093
+4927,0.002060913,-0.004555506,0.01790338
+4928,0.002565348,-0.004291735,0.02010012
+4929,0.002564906,-0.004291999,0.02082314
+4930,0.001774694,-0.004674448,0.01963649
+4931,0.00261246,-0.004263221,0.02347904
+4932,0.002674886,-0.004224333,0.02433783
+4933,0.001558229,-0.004750992,0.02328993
+4934,0.00300093,-0.003999302,0.02657542
+4935,0.002794547,-0.004146144,0.02753644
+4936,0.002787147,-0.004151122,0.02824893
+4937,0.002189453,-0.004495141,0.02689876
+4938,0.002857235,-0.004103195,0.03055558
+4939,0.002762634,-0.004167476,0.0314815
+4940,0.002774146,-0.004159821,0.03220482
+4941,0.002009502,-0.004578417,0.03077128
+4942,0.001981371,-0.004590661,0.03399125
+4943,0.002734751,-0.004185826,0.03446094
+4944,0.002556652,-0.004296921,0.03517796
+4945,0.002653912,-0.004237541,0.03895906
+4946,0.002702592,-0.004206661,0.03966
+4947,0.001857559,-0.004642141,0.0386438
+4948,0.002838588,-0.004116117,0.04059691
+4949,0.002134183,0.004521644,0.003776509
+4950,0.001648026,0.004720594,0.003815579
+4951,0.001179428,0.004858904,0.004103237
+4952,0.0003479952,0.004987875,0.004500819
+4953,-0.0002931169,0.004991401,0.004612828
+4954,0.001184276,0.004857725,0.004985338
+4955,-0.001191815,0.004855881,0.004783857
+4956,-0.001878538,0.004633691,0.004614158
+4957,-0.0005556984,0.004969024,0.005553949
+4958,-0.002559903,0.004294985,0.004257125
+4959,-0.003200798,0.00384121,0.004298728
+4960,-0.002155544,0.0045115,0.005367944
+4961,-0.003750778,0.003306307,0.004420392
+4962,-0.004211149,0.002695593,0.00436323
+4963,-0.003414193,0.003652846,0.005132575
+4964,-0.004570143,0.002028249,0.004413954
+4965,-0.004802238,0.001392305,0.004500015
+4966,-0.00435426,0.002457726,0.005304963
+4967,-0.004951611,0.0006939404,0.00447754
+4968,-0.004999791,0.00004570437,0.004433748
+4969,-0.004880349,0.001087287,0.005333211
+4970,-0.00496324,-0.0006051877,0.00427035
+4971,-0.004844077,-0.001238917,0.004289675
+4972,-0.004992652,-0.000270972,0.005147337
+4973,-0.004645695,-0.001848652,0.004536738
+4974,-0.004380345,-0.002410929,0.004585706
+4975,-0.004757033,-0.001539687,0.005231002
+4976,-0.003977056,-0.00303035,0.004579795
+4977,-0.003563105,-0.003507746,0.004435957
+4978,-0.004156611,-0.002778954,0.005472154
+4979,-0.002983274,-0.00401249,0.004177288
+4980,-0.002441662,-0.004363289,0.004135797
+4981,-0.003142483,-0.003889062,0.005207575
+4982,-0.001910433,-0.004620632,0.00440108
+4983,-0.001190073,-0.004856308,0.004761952
+4984,-0.0005048061,-0.004974452,0.004874792
+4985,-0.001826642,-0.004654393,0.005309778
+4986,0.0004442894,-0.004980222,0.004967421
+4987,0.001147778,-0.004866478,0.004827696
+4988,-0.0001606971,-0.004997417,0.005763279
+4989,0.001698789,-0.004702565,0.00541511
+4990,0.002040248,-0.004564799,0.004386898
+4991,0.003009722,0.00399269,0.006310912
+4992,0.002948668,0.004037989,0.005617641
+4993,0.002093271,0.004540729,0.005494628
+4994,0.002884915,0.004083781,0.007072135
+4995,0.001101755,0.004877103,0.02469993
+4996,0.001931185,0.004611998,0.02397907
+4997,0.002925402,0.004054877,0.009026236
+4998,0.002764481,0.004166251,0.00813257
+4999,0.003048737,0.003962979,0.02185572
+5000,0.002785067,0.004152518,0.02131052
+5001,0.001401275,0.004799628,0.02297921
+5002,0.002668689,0.00422825,0.02320128
+5003,-0.002228218,-0.004476052,0.04434826
+5004,0.001921259,0.004616142,0.045698
+5005,0.001845192,0.004647071,0.02831777
+5006,0.002584,0.004280531,0.03155615
+5007,0.00245479,0.004355916,0.03076321
+5008,0.001379621,0.004805897,0.03026332
+5009,0.001894138,0.004627336,0.03205062
+5010,0.002685891,0.004217344,0.03791854
+5011,-0.004067634,-0.002907638,0.04598756
+5012,-0.004377536,-0.002416024,0.04574706
+5013,-0.00442567,-0.002326681,0.04478313
+5014,-0.003686469,-0.003377861,0.04593365
+5015,0.002693822,0.004212283,0.03968792
+5016,0.002666,0.004229946,0.03886827
+5017,0.001849824,0.004645229,0.03822832
+5018,0.001847884,0.004646001,0.04015752
+5019,-0.004739139,0.001593915,0.04524852
+5020,-0.004453728,0.002272511,0.04558625
+5021,-0.004854268,0.001198366,0.04428507
+5022,0.0020713,0.004550793,0.007461935
+5023,0.002837737,0.004116704,0.01000678
+5024,0.001838249,0.004649822,0.009502912
+5025,-0.003542899,-0.003528154,0.04484739
+5026,0.002908778,0.004066818,0.01628263
+5027,0.002780744,0.004155414,0.01550553
+5028,0.001907808,0.004621717,0.01514943
+5029,0.002288524,0.004445521,0.01678107
+5030,0.001531534,-0.004759664,0.03550835
+5031,0.001455649,0.004783418,0.04479911
+5032,0.001211501,0.004851007,0.04382347
+5033,0.001275771,-0.004834502,0.0447827
+5034,0.00197207,-0.004594664,0.04036527
+5035,-0.003996303,-0.003004923,0.044169
+5036,-0.004399212,-0.002376327,0.04378689
+5037,-0.003502979,-0.003567792,0.04385115
+5038,0.0004145355,0.004982786,0.01206691
+5039,0.0005017506,0.004974761,0.01108472
+5040,0.002991629,0.004006265,0.02248778
+5041,0.002036642,-0.004566409,0.02885258
+5042,0.001972919,-0.0045943,0.02510385
+5043,0.0020926,-0.004541038,0.03249742
+5044,0.003494571,-0.003576028,0.04665615
+5045,-0.004074341,0.002898231,0.04519979
+5046,-0.003926326,0.003095798,0.04420355
+5047,0.00028257,0.004992009,0.006336298
+5048,0.001302251,0.004827437,0.00589221
+5049,0.001234013,0.004845329,0.006845588
+5050,0.001092053,0.004879285,0.007906023
+5051,0.0008109086,0.004933805,0.009946901
+5052,0.0009165696,0.004915272,0.008966358
+5053,0.00003303046,0.004999891,0.008350011
+5054,-0.0004573836,0.004979036,0.01054816
+5055,0.001276153,0.004834401,0.02738237
+5056,0.0008268725,0.004931154,0.0265214
+5057,0.0006253999,0.004960733,0.02833533
+5058,0.00164857,-0.004720404,0.02140779
+5059,0.002589122,0.004277435,0.03572033
+5060,0.002330744,0.004423532,0.03499022
+5061,0.001816705,0.004658281,0.03644848
+5062,-0.00008750798,0.004999234,0.02275057
+5063,0.0007420664,0.004944627,0.02197278
+5064,0.002452648,0.004357122,0.02045517
+5065,0.002227401,0.004476459,0.01978655
+5066,0.001819437,0.004657215,0.02134606
+5067,0.0005134328,0.004973569,0.02556559
+5068,-0.000008564203,0.004999993,0.02462265
+5069,-0.0002885867,0.004991665,0.02644412
+5070,-0.004323175,0.002512002,0.04328269
+5071,-0.003701427,0.003361464,0.04306804
+5072,0.001646996,-0.004720954,0.006377388
+5073,0.001666314,-0.00471417,0.00735591
+5074,0.0008067512,-0.004934486,0.00683443
+5075,0.00100309,-0.004898348,0.04179439
+5076,0.000878919,-0.004922144,0.04275502
+5077,0.001031298,0.004892486,0.01587006
+5078,0.0008958427,0.004919092,0.01500339
+5079,-0.000822894,0.00493182,0.0430702
+5080,0.0001122368,0.00499874,0.04334946
+5081,0.001060888,0.004886156,0.04060332
+5082,0.001039909,0.004890664,0.03962384
+5083,0.0003253861,0.004989401,0.03119509
+5084,0.0001543186,0.004997618,0.0302025
+5085,-0.002727252,-0.004190716,0.04346992
+5086,-0.00328,-0.003773804,0.04279152
+5087,-0.001952469,-0.004603028,0.04328863
+5088,0.0006461498,0.004958073,0.0131178
+5089,-0.0005359519,0.004971193,0.01273687
+5090,0.0007547757,0.004942703,0.01403527
+5091,0.0004457299,-0.004980093,0.03491522
+5092,0.0002927272,-0.004991424,0.03573871
+5093,0.001004857,-0.004897986,0.009277926
+5094,0.00105727,-0.00488694,0.01019568
+5095,0.0009094406,-0.004916596,0.02824079
+5096,0.0009925917,-0.004900486,0.02923358
+5097,0.001105602,-0.004876233,0.03236947
+5098,0.00130502,-0.004826689,0.03316969
+5099,0.0008798395,0.00492198,0.04261276
+5100,0.0008396216,0.004928999,0.04163788
+5101,-0.000001593701,0.005,0.04110419
+5102,-0.0002708992,0.004992656,0.02918751
+5103,-0.0008660815,0.004924419,0.02825211
+5104,-0.001327074,0.004820671,0.03011928
+5105,-0.004461688,-0.002256842,0.04274431
+5106,-0.004765345,-0.001513767,0.04335845
+5107,0.002042003,0.004564014,0.03429569
+5108,0.0017023,0.004701295,0.03353732
+5109,0.001457483,0.004782859,0.03492384
+5110,-0.004959954,-0.0006315531,0.04323391
+5111,-0.0006257486,0.004960689,0.006507327
+5112,-0.002637483,-0.004247786,0.005942213
+5113,-0.001965126,-0.004597639,0.006303085
+5114,-0.001075123,-0.004883043,0.006672833
+5115,-0.0001330251,-0.00499823,0.006765463
+5116,-0.00193964,-0.004608449,0.007305268
+5117,0.0001159182,-0.004998656,0.04332935
+5118,-0.0007972444,-0.004936031,0.04322678
+5119,0.0009561416,-0.004907728,0.02538114
+5120,0.001433178,-0.004790198,0.02621503
+5121,-0.0001609717,0.004997408,0.01475589
+5122,-0.000112557,-0.004998733,0.007743984
+5123,-0.0007666544,0.004940875,0.007651522
+5124,-0.00158162,0.004743256,0.006869173
+5125,-0.0009431511,0.004910241,0.008711858
+5126,-0.0007560712,0.004942505,0.0238754
+5127,-0.001414866,0.004795639,0.02286898
+5128,-0.001338971,0.004817381,0.02474106
+5129,0.0006682601,-0.004955142,0.02092069
+5130,0.0006213223,-0.004961246,0.0218228
+5131,0.001084745,0.004880915,0.03293594
+5132,0.0007173383,0.004948275,0.03214123
+5133,-0.0005226337,0.00497261,0.0320804
+5134,0.0005133008,0.004973582,0.03362793
+5135,0.0007970608,0.004936061,0.03860387
+5136,0.0008202978,0.004932252,0.03765414
+5137,-0.0000232775,0.004999946,0.03904967
+5138,0.001159439,-0.004863713,0.04379777
+5139,0.0003540826,0.004987447,0.02111743
+5140,0.001068446,-0.004884508,0.03986781
+5141,0.001227462,-0.004846993,0.04080472
+5142,0.0009407886,0.004910694,0.04545905
+5143,0.002197487,0.004491219,0.01894455
+5144,0.001976379,0.004592812,0.01817639
+5145,0.001418636,0.004794525,0.01964872
+5146,0.0009865017,-0.004901715,0.0338633
+5147,-0.0002705113,-0.004992677,0.03409366
+5148,0.0004645622,-0.004978371,0.03719341
+5149,0.0007323289,-0.004946079,0.03795712
+5150,0.00005954153,-0.004999645,0.04129693
+5151,0.00004993799,-0.004999751,0.01058173
+5152,0.001226603,-0.00484721,0.0111489
+5153,0.0006332438,-0.004959738,0.01301547
+5154,0.0004510152,-0.004979617,0.01378664
+5155,-0.0001927473,-0.004996283,0.0297256
+5156,0.0009838463,-0.004902249,0.03033738
+5157,0.0008580303,-0.004925828,0.01491802
+5158,0.001408816,-0.00479742,0.01551352
+5159,0.0008714584,-0.00492347,0.0312633
+5160,0.00003716687,-0.004999862,0.03193557
+5161,0.001307486,-0.004826021,0.01636562
+5162,0.001286,-0.004831791,0.01732665
+5163,0.001069204,-0.004884343,0.01819056
+5164,0.001188754,-0.004856631,0.02717606
+5165,0.0001018354,-0.004998963,0.02755706
+5166,0.000942579,-0.004910351,0.01914598
+5167,0.000857093,-0.004925991,0.02001518
+5168,0.0004845697,-0.004976464,0.02276594
+5169,0.000436727,-0.00498089,0.02374597
+5170,0.001467215,-0.004779883,0.008370149
+5171,0.0003530891,-0.004987517,0.008720729
+5172,-0.001358532,-0.004811901,0.04234845
+5173,0.0006933095,-0.004951699,0.03874167
+5174,-0.003924861,-0.003097655,0.0419298
+5175,-0.004433913,-0.002310934,0.04150136
+5176,-0.0003714056,0.004986187,0.03686062
+5177,0.000720119,0.004947871,0.03648506
+5178,0.001001538,-0.004898665,0.01206845
+5179,-0.0001495088,-0.004997764,0.01248199
+5180,-0.001292749,-0.00482999,0.02911413
+5181,-0.001301365,-0.004827675,0.03021793
+5182,-0.001025677,-0.004893668,0.0105492
+5183,-0.0008548499,-0.004926381,0.01150243
+5184,-0.0005234452,-0.004972525,0.02227884
+5185,-0.002257696,-0.004461256,0.03096598
+5186,-0.001215343,-0.004850046,0.03157745
+5187,-0.0009602642,-0.004906923,0.02670788
+5188,-0.001238942,-0.004844071,0.02777262
+5189,-0.001586864,-0.004741504,0.02172555
+5190,-0.001716734,-0.004696044,0.02266869
+5191,-0.001549792,0.004753751,0.03758213
+5192,-0.001645864,0.004721349,0.03641304
+5193,-0.001220037,-0.004848867,0.01244945
+5194,-0.0007660392,0.00494097,0.03995699
+5195,-0.001009167,0.004897099,0.03893702
+5196,-0.002239018,0.00447066,0.03848945
+5197,-0.0009879202,0.00490143,0.04099155
+5198,-0.002254893,0.004462674,0.006209182
+5199,-0.002905949,0.00406884,0.005852148
+5200,-0.003494224,0.003576367,0.005973812
+5201,-0.003689297,0.003374772,0.006864058
+5202,-0.00409981,0.00286209,0.006144485
+5203,-0.004485243,0.002209659,0.006195209
+5204,-0.00481309,0.001354313,0.006184734
+5205,-0.00495694,0.0006547898,0.006162259
+5206,-0.004661858,0.001807506,0.007024257
+5207,-0.004993878,-0.000247357,0.006006766
+5208,-0.004919247,-0.0008949888,0.005843368
+5209,-0.004999922,0.00002794249,0.00685829
+5210,-0.004764262,-0.001517172,0.006090431
+5211,-0.004402036,-0.002371092,0.006572485
+5212,-0.004004383,-0.002994147,0.006566574
+5213,-0.004677686,-0.001766141,0.007184851
+5214,-0.003257471,-0.003793268,0.006200882
+5215,-0.00112639,0.004871473,0.01565429
+5216,-0.001265268,0.004837261,0.01468617
+5217,-0.001311255,0.004824998,0.01367042
+5218,-0.001534548,0.004758693,0.01261953
+5219,-0.002221455,0.004479413,0.01456882
+5220,-0.0009823247,-0.004902554,0.03268362
+5221,-0.001511431,-0.004766086,0.03373554
+5222,0.00157788,0.004744502,0.01749416
+5223,0.001308323,0.004825794,0.01672919
+5224,0.0002668855,0.004992872,0.01658314
+5225,0.000972279,0.004904556,0.0181245
+5226,-0.001417593,0.004794834,0.02706302
+5227,-0.001717922,0.004695609,0.02610722
+5228,-0.002251387,0.004464443,0.02791521
+5229,-0.004990622,-0.0003060933,0.0422474
+5230,-0.004978529,0.0004628711,0.04316544
+5231,-0.00283977,0.004115301,0.04298764
+5232,-0.001949635,0.004604229,0.04299401
+5233,-0.004765586,0.001513008,0.04329856
+5234,-0.003603426,-0.003466312,0.007301212
+5235,-0.003391025,0.003674364,0.04206678
+5236,-0.004648773,0.001840899,0.04216306
+5237,-0.004854149,0.001198847,0.04114208
+5238,-0.004477863,0.002224578,0.04112621
+5239,-0.004877925,-0.001098113,0.04122362
+5240,-0.004999989,-0.00001035867,0.04115515
+5241,-0.004983217,0.0004093298,0.0401183
+5242,-0.004562843,-0.002044618,0.04040911
+5243,-0.001384753,0.004804421,0.04206257
+5244,-0.002287327,-0.004446137,0.02826495
+5245,-0.001268714,0.004836359,0.009757436
+5246,-0.002025517,0.004571354,0.009058946
+5247,-0.001567752,0.004747858,0.01089525
+5248,-0.002699854,0.004208419,0.0354355
+5249,-0.001618336,0.004730855,0.03471399
+5250,-0.003233865,-0.003813413,0.04154857
+5251,-0.0006432118,-0.004958455,0.03660029
+5252,-0.000588583,-0.004965236,0.008651762
+5253,0.0005330596,0.004971504,0.01992982
+5254,0.0004998805,0.004974949,0.01908783
+5255,0.00007419123,0.00499945,0.0184056
+5256,-0.0005819754,0.004966015,0.02055654
+5257,-0.000742727,-0.004944528,0.04036845
+5258,-0.0009694998,-0.004905107,0.04135812
+5259,-0.0001122622,-0.00499874,0.01456039
+5260,-0.0002486517,-0.004993813,0.02579694
+5261,-0.001575282,-0.004745365,0.0260125
+5262,0.0001246168,-0.004998447,0.01856925
+5263,-0.002768509,-0.004163575,0.02323671
+5264,-0.00180214,-0.004663935,0.02379
+5265,-0.0001956738,-0.00499617,0.02043019
+5266,-0.0007704551,-0.004940283,0.02416177
+5267,0.0003255238,-0.004989392,0.02468576
+5268,-0.002019502,0.004574015,0.03115013
+5269,-0.002400863,0.00438587,0.03013515
+5270,-0.002112362,-0.004531879,0.04141997
+5271,-0.002443596,-0.004362206,0.01249782
+5272,-0.001802077,-0.00466396,0.01347737
+5273,0.0006615412,0.004956043,0.03565496
+5274,0.000342062,0.004988286,0.03496042
+5275,-0.002113261,0.00453146,0.01193604
+5276,-0.002828627,0.004122969,0.01114532
+5277,-0.002799757,0.004142627,0.01286959
+5278,-0.001725093,0.004692979,0.0207625
+5279,-0.001555354,0.004751934,0.01957489
+5280,-0.00009145675,-0.004999163,0.03918113
+5281,-0.001117174,-0.004873594,0.03924232
+5282,-0.001827028,0.004654242,0.03243535
+5283,-0.002849096,0.004108851,0.03245122
+5284,-0.0003010792,0.004990927,0.03435904
+5285,-0.002400702,0.004385958,0.02535996
+5286,-0.002380967,0.004396703,0.007353377
+5287,-0.003855894,0.003183093,0.04103801
+5288,-0.003030762,0.003976743,0.04095761
+5289,0.0002760095,-0.004992376,0.01665279
+5290,-0.004249019,0.002635496,0.04001704
+5291,-0.0005080659,0.00497412,0.01752239
+5292,-0.0007905901,0.004937101,0.01666326
+5293,-0.001865832,0.004638822,0.01659354
+5294,-0.0009803479,0.00490295,0.01848572
+5295,-0.00184407,-0.004647516,0.03589114
+5296,-0.001682818,-0.004708304,0.03734585
+5297,-0.00365729,-0.003409433,0.008504733
+5298,-0.002828377,-0.00412314,0.008139041
+5299,-0.001926994,-0.004613751,0.0347991
+5300,-0.002863949,-0.004098512,0.03554466
+5301,-0.002198303,0.00449082,0.02191685
+5302,-0.003045324,0.003965602,0.02093521
+5303,-0.002779789,0.004156052,0.02304168
+5304,-0.00282989,-0.004122102,0.03770718
+5305,-0.001728037,-0.004691896,0.03841632
+5306,-0.004458789,-0.002262564,0.008841288
+5307,-0.003909405,-0.003117139,0.009679117
+5308,-0.002645445,0.004242832,0.008304228
+5309,-0.00323459,0.003812798,0.007644237
+5310,-0.002922676,0.004056842,0.009349806
+5311,-0.001576914,-0.004744823,0.009485534
+5312,-0.002408799,-0.004381517,0.01040623
+5313,-0.002325249,-0.004426423,0.03960364
+5314,-0.003717634,-0.00334353,0.03732091
+5315,-0.003749629,-0.003307609,0.03839139
+5316,-0.003814359,0.003232749,0.03630788
+5317,-0.003795465,0.003254911,0.03460882
+5318,-0.00350794,0.003562914,0.02564213
+5319,-0.003213417,0.00383066,0.02427598
+5320,-0.002918654,-0.004059737,0.04055824
+5321,-0.003814587,0.00323248,0.03296585
+5322,-0.003946051,0.003070615,0.03168063
+5323,-0.004594247,0.001973042,0.03383823
+5324,-0.003223324,0.003822327,0.01518125
+5325,-0.003259562,0.003791471,0.01416551
+5326,-0.002411998,-0.004379757,0.01425828
+5327,-0.001184953,-0.00485756,0.01420992
+5328,-0.003795453,-0.003254925,0.02249537
+5329,-0.003854216,-0.003185125,0.02361669
+5330,-0.001100457,-0.004877396,0.01983315
+5331,-0.001286004,-0.00483179,0.02073867
+5332,-0.001454786,0.00478368,0.03338149
+5333,-0.002547206,-0.004302527,0.02564073
+5334,-0.003646003,-0.0034215,0.02500445
+5335,-0.003395869,-0.003669887,0.02628716
+5336,-0.004438361,-0.00230238,0.02426312
+5337,-0.002988342,-0.004008717,0.01161834
+5338,-0.003454766,-0.003614497,0.01264626
+5339,-0.002103034,0.004536215,0.04091536
+5340,-0.002696003,0.004210887,0.03988659
+5341,-0.003888816,0.003142787,0.007814909
+5342,-0.004173101,0.002754129,0.008687988
+5343,-0.004486911,0.002206271,0.007907809
+5344,-0.004814112,0.001350678,0.007897335
+5345,-0.004950118,0.0007045073,0.008678448
+5346,-0.004992643,0.0002711343,0.007794895
+5347,-0.004960001,-0.0006311783,0.007639402
+5348,-0.000751737,-0.004943166,0.01624781
+5349,-0.0007737245,-0.004939772,0.01720884
+5350,-0.0007824364,-0.0049384,0.01534129
+5351,-0.001797501,-0.004665725,0.01589734
+5352,-0.003555497,0.003515458,0.03020619
+5353,-0.003001668,0.003998748,0.02917534
+5354,-0.003434755,0.003633519,0.02798624
+5355,-0.004343542,0.00247662,0.03072081
+5356,-0.002011601,-0.004577495,0.00850879
+5357,-0.003293917,-0.003761663,0.02758597
+5358,-0.003335557,-0.00372479,0.02892748
+5359,-0.002567516,-0.004290438,0.03338906
+5360,-0.001905716,-0.00462258,0.02472979
+5361,-0.003323894,0.003735202,0.01030373
+5362,-0.003814,0.003233173,0.009549007
+5363,-0.003738653,0.003320011,0.01134452
+5364,-0.002422192,-0.004374127,0.02112851
+5365,-0.003323655,-0.003735414,0.03014668
+5366,-0.003256729,-0.003793905,0.0315062
+5367,-0.004127794,-0.002821581,0.0294677
+5368,-0.004758063,-0.001536501,0.008121456
+5369,-0.004862414,-0.001164871,0.009295839
+5370,-0.003330536,-0.00372928,0.01475779
+5371,-0.002821277,-0.004128001,0.01549034
+5372,-0.00209774,0.004538666,0.01869169
+5373,-0.000609922,-0.00496266,0.01806521
+5374,-0.0007380107,-0.004945234,0.01902063
+5375,-0.001612827,-0.004732736,0.01766022
+5376,-0.003425888,-0.00364188,0.01055467
+5377,-0.001803989,-0.00466322,0.01932911
+5378,-0.003636835,-0.003431243,0.03604399
+5379,-0.004363752,-0.002440833,0.0367282
+5380,-0.003697692,-0.003365571,0.03495195
+5381,-0.003704902,0.003357633,0.01348202
+5382,-0.002672467,0.004225863,0.01755552
+5383,-0.002955219,0.004033197,0.01654655
+5384,-0.003155148,0.003878794,0.01864469
+5385,-0.003809766,0.00323816,0.02332385
+5386,-0.003411357,-0.003655495,0.03973225
+5387,-0.003860291,0.003177759,0.01614323
+5388,-0.002404466,-0.004383896,0.01841796
+5389,-0.002721011,-0.004194771,0.01923048
+5390,-0.004300856,-0.002550028,0.01089123
+5391,-0.003149433,0.003883435,0.0385317
+5392,-0.004995365,-0.0002152302,0.03907563
+5393,-0.004899197,0.0009989359,0.03906256
+5394,-0.003197075,-0.003844309,0.02027631
+5395,-0.003432158,-0.003635972,0.02126319
+5396,-0.004336945,-0.002488154,0.02164317
+5397,-0.003677103,-0.003388055,0.01936516
+5398,-0.004173465,-0.002753578,0.03934599
+5399,-0.00421226,-0.002693857,0.02694969
+5400,-0.004998974,0.0001012757,0.009546885
+5401,-0.004953171,-0.0006827111,0.01026672
+5402,-0.004739546,-0.001592702,0.03906825
+5403,-0.004433905,0.002310949,0.009641907
+5404,-0.004552543,0.002067451,0.03906492
+5405,-0.003964296,0.003047024,0.03897672
+5406,-0.003839973,-0.003202281,0.01376541
+5407,-0.004129632,-0.00281889,0.01499747
+5408,-0.004222612,-0.002677601,0.01288594
+5409,-0.003622492,0.003446382,0.03757958
+5410,-0.003673867,0.003391564,0.01985252
+5411,-0.004085301,0.002882762,0.01871635
+5412,-0.004002996,0.002996001,0.02100687
+5413,-0.004774806,0.001483652,0.03802224
+5414,-0.004816486,-0.001342185,0.01114881
+5415,-0.004576388,-0.002014118,0.01202436
+5416,-0.00477416,-0.00148573,0.01314352
+5417,-0.004999329,-0.00008188889,0.01139986
+5418,-0.004460163,0.002259855,0.0367529
+5419,-0.003316601,-0.003741679,0.03270009
+5420,-0.003634498,-0.003433719,0.03376364
+5421,-0.004256266,-0.002623776,0.03426297
+5422,-0.004163292,-0.002768935,0.03188078
+5423,-0.004680632,0.001758318,0.01051034
+5424,-0.00485724,0.001186264,0.009649325
+5425,-0.004926795,0.000852464,0.03474405
+5426,-0.004931735,0.0008234043,0.03310108
+5427,-0.004452838,0.002274254,0.017449
+5428,-0.004597534,0.001965369,0.0160837
+5429,-0.004730613,0.001619042,0.01865682
+5430,-0.004382169,0.002407613,0.02813966
+5431,-0.003890273,0.003140983,0.02687953
+5432,-0.004740466,-0.001589964,0.03583107
+5433,-0.004777037,-0.001476454,0.03710799
+5434,-0.004430226,0.002317993,0.02579554
+5435,-0.004743019,0.001582331,0.02937033
+5436,-0.004912158,0.0009331165,0.02826362
+5437,-0.004896785,0.00101069,0.03084477
+5438,-0.00490337,0.0009782423,0.02592741
+5439,-0.004760357,0.001529378,0.02469002
+5440,-0.00478468,-0.001451496,0.0288714
+5441,-0.004780024,-0.001466756,0.03009059
+5442,-0.004108043,0.00285026,0.01236128
+5443,-0.004433394,0.00231193,0.01151968
+5444,-0.004856977,0.001187338,0.0115271
+5445,-0.004409798,0.002356626,0.01365719
+5446,-0.004852102,0.001207107,0.03675054
+5447,-0.002795574,-0.004145451,0.01639685
+5448,-0.00456906,0.002030687,0.0234982
+5449,-0.004322343,0.002513433,0.0222639
+5450,-0.004686052,0.001743822,0.02118121
+5451,-0.004955783,0.0006634844,0.02363007
+5452,-0.002548144,-0.004301972,0.0175616
+5453,-0.004774671,-0.001484089,0.03472909
+5454,-0.004979252,-0.0004550222,0.03510888
+5455,-0.004972485,0.0005238279,0.01240919
+5456,-0.004895299,-0.001017866,0.0380125
+5457,-0.004702408,-0.001699223,0.02033062
+5458,-0.004855013,-0.001195345,0.0215628
+5459,-0.004699632,0.001706886,0.01465647
+5460,-0.004880919,0.001084725,0.01353572
+5461,-0.004996494,-0.0001872199,0.01340847
+5462,-0.004956593,0.000657408,0.01596223
+5463,-0.004999132,-0.00009314469,0.03711536
+5464,-0.004944543,0.000742625,0.03584603
+5465,-0.004905337,-0.0009683333,0.02384862
+5466,-0.004834627,-0.001275296,0.02523638
+5467,-0.004683344,-0.001751081,0.01503266
+5468,-0.004377012,-0.002416975,0.01602503
+5469,-0.00470732,-0.001685567,0.02637459
+5470,-0.004659309,-0.001814066,0.0276734
+5471,-0.004746261,-0.001572579,0.03354079
+5472,-0.004990938,-0.0003008978,0.02596009
+5473,-0.004980857,-0.0004371066,0.0226568
+5474,-0.004969241,0.0005537538,0.02706562
+5475,-0.00498796,-0.0003467747,0.0282963
+5476,-0.004968022,-0.0005645883,0.03290879
+5477,-0.00496335,0.000604283,0.03200296
+5478,-0.004671995,-0.001781141,0.03244267
+5479,-0.004911922,-0.0009343576,0.01427005
+5480,-0.003468279,-0.003601533,0.01715459
+5481,-0.004981271,0.0004323626,0.02134425
+5482,-0.004978136,-0.0004670798,0.01529761
+5483,-0.004897956,0.001004999,0.02008721
+5484,-0.004643104,-0.001855151,0.03124878
+5485,-0.004222259,-0.002678157,0.0170885
+5486,-0.004058266,-0.002920698,0.01825324
+5487,-0.004374613,-0.002421314,0.01929907
+5488,-0.004739682,-0.001592299,0.01712369
+5489,-0.004990979,0.0003002206,0.01881986
+5490,-0.004985924,-0.0003749124,0.03065248
+5491,-0.004872783,-0.001120708,0.0192187
+5492,-0.004996398,-0.0001897641,0.01672484
+5493,-0.004975671,-0.0004926419,0.01778831
+5494,-0.002264554,-0.005011018,0.04835991
+5495,-0.001762118,-0.005196067,0.04835518
+5496,-0.002031248,-0.005109662,0.04892575
+5497,0.005087277,-0.002085659,0.02517501
+5498,0.005229689,-0.001589939,0.02470257
+5499,0.004995994,-0.002298894,0.02449104
+5500,0.005230581,0.001648407,0.0224869
+5501,0.005392957,0.001071924,0.02221429
+5502,0.005391832,0.001078262,0.02276858
+5503,0.005226917,0.00168163,0.02692906
+5504,0.005223854,0.00168963,0.02747269
+5505,0.004877767,0.002463651,0.02694828
+5506,0.004874704,0.002471652,0.02749191
+5507,0.005208267,0.00169486,0.01360299
+5508,0.005220151,0.001666174,0.014154
+5509,0.005392933,0.001076328,0.01389063
+5510,-0.005375297,0.0009210985,0.04436955
+5511,-0.005495089,-0.00008617918,0.04419756
+5512,-0.005473426,0.0004596764,0.0431578
+5513,0.00371982,-0.004050914,0.02166358
+5514,0.003819592,-0.003953147,0.02069935
+5515,0.002836531,-0.004624028,0.02100099
+5516,0.004526451,-0.003099357,0.03648293
+5517,0.004959305,-0.00234367,0.03635227
+5518,0.004881305,-0.002524448,0.03704483
+5519,0.005440779,0.0008048529,0.002259444
+5520,0.005354834,0.00120264,0.001880854
+5521,0.005448797,0.0007458095,0.001768739
+5522,-0.002751747,-0.00476206,0.04834874
+5523,-0.002964928,-0.004625259,0.04775673
+5524,-0.002523468,-0.004882437,0.04778231
+5525,0.001227586,-0.005310804,0.04525294
+5526,0.0008781778,-0.005414485,0.04420211
+5527,0.002081237,-0.005085535,0.04566354
+5528,0.001731829,-0.005189216,0.04461271
+5529,-0.002725097,-0.004777431,0.04706161
+5530,-0.003135494,-0.004484574,0.04653319
+5531,-0.003375326,-0.004332403,0.0472283
+5532,0.00483066,0.002609483,0.004473958
+5533,0.005073365,0.002116466,0.004858113
+5534,0.005098962,0.00204708,0.004263157
+5535,0.0055,-1.347111E-018,0.04275072
+5536,0.005460876,-0.0004829195,0.04297571
+5537,0.0055,-1.347111E-018,0.04324904
+5538,0.001813452,0.00516166,0.02188468
+5539,0.001018162,0.005393849,0.02266247
+5540,0.001811514,0.005162142,0.02310095
+5541,0.001016224,0.005394331,0.02387875
+5542,0.004214424,-0.003524001,0.02500853
+5543,0.00323344,-0.004354378,0.02505033
+5544,0.003966072,-0.003809686,0.02426102
+5545,0.005400102,0.001025495,0.001354221
+5546,0.005239166,-0.001502053,0.03410144
+5547,0.005203266,-0.001690401,0.03465592
+5548,0.005408005,-0.0009905547,0.03440704
+5549,0.005372106,-0.001178903,0.03496153
+5550,0.005440575,-0.0005418418,0.02689784
+5551,0.005372022,-0.00117951,0.02719135
+5552,0.005440575,-0.0005418418,0.02752886
+5553,0.0001036206,0.005487341,0.0447808
+5554,0.0009007855,0.00541281,0.04457699
+5555,0.0003686836,0.005486393,0.0438508
+5556,-0.004819395,0.002569952,0.008072987
+5557,-0.004211105,0.003491644,0.007980087
+5558,-0.004494086,0.002972095,0.009105696
+5559,-0.005102377,0.002050403,0.009198596
+5560,-0.0009395956,-0.005418991,0.03494173
+5561,-0.000394789,-0.005448509,0.03388981
+5562,0.0004342281,-0.005346357,0.03505029
+5563,0.0009790347,-0.005375876,0.03399837
+5564,-0.004362828,-0.003346399,0.001759902
+5565,-0.004204566,-0.003542699,0.001133869
+5566,-0.004496703,-0.003141674,0.00118031
+5567,0.005419747,-0.0009333399,0.003270458
+5568,0.005419134,-0.0009366073,0.002660242
+5569,0.005462371,-0.0004736667,0.003045671
+5570,-0.002602394,-0.004823901,0.006721254
+5571,-0.002475262,-0.004902838,0.005727948
+5572,-0.001771748,-0.005178936,0.00608882
+5573,-0.004317617,-0.003392376,0.00047194
+5574,-0.004609755,-0.002991351,0.0005183813
+5575,0.00212351,0.005071138,0.04950504
+5576,0.002012521,-0.005116458,0.02068352
+5577,0.001967835,-0.005132064,0.02158563
+5578,0.005229839,-0.001651969,0.03324209
+5579,0.005237301,-0.0016181,0.03378692
+5580,0.00500701,-0.002256683,0.0335261
+5581,0.005463392,-0.0004672318,0.03409868
+5582,0.005408509,-0.0009881949,0.03382907
+5583,0.005463392,-0.0004672318,0.03356193
+5584,-0.001135371,0.005381211,0.04620892
+5585,-0.0009175393,0.005414595,0.04705359
+5586,-0.001482076,0.005285954,0.0469623
+5587,0.005455055,0.000517347,0.01136369
+5588,0.005455055,0.000517347,0.01199695
+5589,0.005393237,0.00106986,0.01167308
+5590,0.001679501,-0.005234902,0.03481993
+5591,0.004012266,-0.003746775,0.029995
+5592,0.004616326,-0.002930426,0.03048905
+5593,0.004645197,-0.002871568,0.02980892
+5594,0.005416097,0.0009568701,0.02775095
+5595,0.005416821,0.0009526832,0.02830769
+5596,0.00545573,0.0005134766,0.02751945
+5597,0.005456455,0.0005092896,0.02807619
+5598,0.004072639,0.003654443,0.03601051
+5599,0.004047444,0.003687864,0.03538482
+5600,0.003360208,0.004340104,0.03577164
+5601,-0.002020976,-0.005100256,0.04771433
+5602,-0.00151854,-0.005285305,0.04770959
+5603,0.005372274,0.00117592,0.04952757
+5604,-0.005467092,-0.0005935393,0.04830347
+5605,-0.00548711,-0.000277551,0.04765281
+5606,-0.005473427,-0.0001175318,0.04843783
+5607,-0.005493445,0.0001984566,0.04778717
+5608,0.003527072,0.004208365,0.01503381
+5609,0.003581072,0.004155421,0.0141655
+5610,0.0026938,0.004733266,0.01467771
+5611,0.005128328,-0.001935463,0.04910551
+5612,0.005062533,-0.002138456,0.04859498
+5613,0.004930926,-0.002432659,0.04907937
+5614,-0.002947102,-0.004638199,0.04898946
+5615,-0.002492833,-0.00489064,0.04892634
+5616,-0.002752208,-0.004761796,0.04946928
+5617,-0.001501483,0.0052909,0.04343527
+5618,-0.001533085,0.005281993,0.04448331
+5619,-0.0008253408,0.005396494,0.04450153
+5620,-0.005420339,-0.0008517319,0.04768997
+5621,-0.005396289,-0.001043266,0.04693316
+5622,-0.00546306,-0.0004690848,0.046896
+5623,-0.004961833,-0.002372794,0.04782898
+5624,-0.005148577,-0.001869237,0.04780515
+5625,-0.005072602,-0.002108588,0.04721921
+5626,0.005230747,-0.001610164,0.04703397
+5627,0.004938008,-0.002410571,0.04694681
+5628,0.0050959,-0.002066277,0.04636949
+5629,0.005023427,0.002221194,0.03776905
+5630,0.004751315,0.002757731,0.03752962
+5631,0.004698288,0.002837655,0.03807146
+5632,0.004974097,0.002334075,0.0127657
+5633,0.005000254,0.002269775,0.01222481
+5634,0.004590563,0.002995224,0.01239847
+5635,0.005316134,0.001344002,0.04652763
+5636,0.005307366,0.001394274,0.04703232
+5637,0.005153973,0.001907789,0.04663278
+5638,0.002101094,-0.005081583,0.0472985
+5639,0.002609651,-0.004798381,0.04674822
+5640,0.001929241,-0.00515024,0.04651528
+5641,0.0052426,0.001597712,0.008629123
+5642,0.005406,0.001007716,0.008897385
+5643,0.005401851,0.001031597,0.008353524
+5644,0.003512162,0.0041634,0.04663914
+5645,0.003301616,0.00437097,0.0472798
+5646,0.002950407,0.004640799,0.04667903
+5647,0.003478667,-0.004251583,0.04728022
+5648,0.003733422,-0.003993957,0.04673411
+5649,0.003183725,-0.004484257,0.04660008
+5650,-0.003162358,-0.00449994,0.04952017
+5651,-0.003359921,-0.004348144,0.04899293
+5652,0.002213293,-0.005032229,0.04953728
+5653,-0.001402217,0.00530652,0.003336501
+5654,-0.001808485,0.005139403,0.004324681
+5655,-0.0007093859,0.00544617,0.004134351
+5656,0.003461119,0.004241168,0.01311681
+5657,0.002573848,0.004819012,0.01362903
+5658,0.003009302,-0.00454446,0.0190016
+5659,0.004057284,-0.003677643,0.01911267
+5660,0.003819975,-0.003952803,0.01997633
+5661,0.004239316,-0.003499586,0.04678973
+5662,0.004101506,-0.003663907,0.04613867
+5663,0.00260763,-0.004837346,0.002273808
+5664,0.002776834,-0.004726592,0.002945637
+5665,0.00323172,-0.004450207,0.002725966
+5666,0.003062515,-0.004560961,0.002054137
+5667,0.003469693,0.004262235,0.04949914
+5668,0.003670927,0.004069123,0.04897879
+5669,0.003285876,0.004410555,0.04900675
+5670,-0.003024307,-0.004371104,0.04068644
+5671,-0.001952508,-0.005141649,0.04055784
+5672,-0.00387006,-0.003872181,0.04015877
+5673,-0.002798262,-0.004642726,0.04003017
+5674,0.0055,-1.347111E-018,0.04225239
+5675,0.005454882,0.0005183379,0.04195845
+5676,0.005455343,0.0005157013,0.04251046
+5677,0.005181436,-0.00175775,0.006947992
+5678,0.00498665,-0.002318405,0.006604973
+5679,0.004973853,-0.002344289,0.007216988
+5680,0.002915764,-0.00466201,0.005841624
+5681,0.003177475,-0.004470129,0.004494878
+5682,0.003494367,-0.004188931,0.006206006
+5683,0.003756078,-0.00399705,0.00485926
+5684,-0.002405657,-0.004890338,0.02534346
+5685,-0.001423872,-0.005295091,0.02571523
+5686,-0.002506794,-0.004853188,0.02395504
+5687,-0.001525008,-0.005257942,0.0243268
+5688,0.005433264,-0.0006292543,0.03020744
+5689,0.0055,-1.347111E-018,0.03050418
+5690,0.005450907,-0.0004930079,0.03079679
+5691,0.005384171,-0.001122262,0.03050005
+5692,-0.001983693,0.005125899,0.04946093
+5693,-0.001485503,0.005288264,0.04948797
+5694,0.004891588,0.002513975,0.00155492
+5695,0.004969077,0.00234775,0.0009733473
+5696,0.004703627,0.002835577,0.001029121
+5697,0.005037162,0.002206555,0.01330933
+5698,0.005209712,0.001688188,0.01303651
+5699,0.0038727,0.003901335,0.04835578
+5700,0.004066241,0.003701299,0.04893488
+5701,0.0004258227,0.005479031,0.04779074
+5702,0.0009588473,0.005409033,0.04774157
+5703,0.0006595735,0.005460303,0.04834815
+5704,-0.005474211,-0.0005041159,0.003886447
+5705,-0.005354559,-0.001136387,0.003905772
+5706,-0.005397346,-0.0009071039,0.002943181
+5707,-0.005277695,-0.001539375,0.002962506
+5708,0.00420708,-0.003536454,0.04538667
+5709,0.00434489,-0.003372134,0.04603773
+5710,0.004617277,-0.002928532,0.04555068
+5711,0.003082931,0.004553726,0.001580298
+5712,0.002787596,0.004718319,0.001053252
+5713,0.003248422,0.004436404,0.001070146
+5714,0.002114639,0.005071531,0.001501059
+5715,0.001664196,0.005238429,0.001973077
+5716,0.002198132,0.005031153,0.002211593
+5717,0.002000452,0.005093526,0.002784736
+5718,0.002489655,0.00490419,0.002745666
+5719,0.00401751,-0.003748886,0.04211297
+5720,0.003305937,-0.004351878,0.04265461
+5721,0.004042666,-0.003719338,0.04304566
+5722,0.004625197,-0.002943057,0.04683165
+5723,0.004897583,-0.002499455,0.04634461
+5724,0.002180292,-0.005040785,0.002486917
+5725,0.001798967,-0.005196831,0.001785177
+5726,0.001584904,-0.005258977,0.002530819
+5727,-0.0001215037,-0.005407594,0.005123247
+5728,-0.000794935,-0.00542858,0.005960153
+5729,-0.0008209273,-0.005426346,0.004879901
+5730,0.001943667,-0.005137315,0.004209574
+5731,0.0014802,-0.005294536,0.003294578
+5732,0.002075588,-0.005076344,0.003250676
+5733,-0.0002198929,-0.005487339,0.004084043
+5734,-0.0005272215,-0.005474556,0.003243062
+5735,0.0001356951,-0.005498275,0.003367633
+5736,-0.0001716335,-0.005485492,0.002526652
+5737,0.004555767,-0.003060464,0.01934514
+5738,0.004922343,-0.002434681,0.02012642
+5739,0.004318458,-0.003335625,0.0202088
+5740,-0.002987546,-0.004609401,0.001076134
+5741,-0.002829493,-0.004715823,0.001663973
+5742,-0.002542804,-0.004868545,0.001123571
+5743,-0.0004053371,0.005482359,0.04716954
+5744,-0.000694226,0.005455212,0.04774814
+5745,-0.0001468989,0.005482936,0.04774221
+5746,0.004743659,0.002775598,0.01188222
+5747,0.005012448,0.002246493,0.01161633
+5748,0.004755854,0.002752316,0.01127375
+5749,0.005329296,-0.001339775,0.04956744
+5750,0.005425182,-0.0008828189,0.04955701
+5751,0.0055,-1.347111E-018,0.008939749
+5752,0.005449478,-0.0005482521,0.009223881
+5753,0.005450585,-0.0005422617,0.008669683
+5754,-0.004316185,0.003364971,0.00615029
+5755,-0.004607164,0.003001569,0.007199909
+5756,-0.003686907,0.004052898,0.005979617
+5757,-0.003977885,0.003689496,0.007029236
+5758,0.005247544,-0.00161377,0.01899228
+5759,0.005000441,-0.002251371,0.01874134
+5760,0.004938486,-0.002406057,0.01954241
+5761,0.005185589,-0.001768455,0.01979336
+5762,0.00002979359,0.005494002,0.0426401
+5763,-0.0005729407,0.005404211,0.04355865
+5764,0.002626107,0.004817098,0.001533377
+5765,0.002330773,0.004981691,0.001006331
+5766,-0.00138394,-0.005310411,0.001618345
+5767,-0.001847066,-0.00518006,0.001727016
+5768,-0.001400304,-0.005307147,0.002336378
+5769,-0.004050467,0.003718645,0.04769728
+5770,-0.003982706,0.003793022,0.04697403
+5771,-0.003670752,0.004080386,0.04765901
+5772,0.003493703,0.004241022,0.04841671
+5773,0.003695476,0.004073234,0.04779369
+5774,0.001639219,0.005242257,0.03490477
+5775,0.0005222644,0.00539135,0.03494135
+5776,0.001690143,0.00522847,0.03612905
+5777,0.0005731887,0.005377563,0.03616564
+5778,0.0055,-1.347111E-018,0.01105569
+5779,0.0055,-1.347111E-018,0.01051894
+5780,0.005458123,0.0004995059,0.01079364
+5781,0.005458123,0.0004995059,0.01025689
+5782,0.004767815,0.002716883,0.02059762
+5783,0.005052785,0.00216321,0.02086977
+5784,0.005052462,0.002164039,0.02030192
+5785,-0.0003255763,0.005488285,0.009814571
+5786,-0.00128859,0.005241642,0.009316893
+5787,-0.0005095649,0.005467005,0.008353965
+5788,0.004884958,0.002517088,0.003850485
+5789,0.004647293,0.002926939,0.00338746
+5790,0.004937782,0.002393426,0.003256516
+5791,0.005413654,0.0009689424,0.01000367
+5792,0.00545778,0.0005015362,0.009702851
+5793,0.00541331,0.0009709728,0.009449629
+5794,0.004739974,-0.002780636,0.04744265
+5795,0.004672363,0.002859071,0.02188905
+5796,0.005042664,0.002185945,0.02215816
+5797,0.005046141,0.002177058,0.02161825
+5798,-0.005256388,0.00158003,0.006273891
+5799,-0.005045491,0.002008115,0.007113413
+5800,-0.005375243,0.00115763,0.007102939
+5801,0.005411086,0.0009793908,0.003846491
+5802,0.005460866,0.0004829844,0.004199527
+5803,0.005408729,0.0009936293,0.004413023
+5804,0.005458508,0.000497223,0.004766059
+5805,0.005253381,0.001545643,0.02083287
+5806,0.005238082,0.001621393,0.02135779
+5807,0.003675005,-0.004049876,0.002675152
+5808,0.003896186,-0.003872183,0.002027732
+5809,0.003452901,-0.004272514,0.002078546
+5810,0.004338381,-0.003380419,0.04735073
+5811,0.004091559,-0.003656702,0.04794003
+5812,0.004453159,-0.003217998,0.04796174
+5813,0.004944167,-0.002408887,0.02929897
+5814,0.005011612,-0.002262208,0.02981184
+5815,-0.003143097,0.004479724,0.001951873
+5816,-0.002736121,0.004770191,0.002251607
+5817,-0.002836347,0.004707896,0.001525345
+5818,0.005409131,0.0009947385,0.03662631
+5819,0.005454264,0.0005218467,0.0368873
+5820,0.005408763,0.0009968213,0.03607012
+5821,0.005453895,0.0005239296,0.03633111
+5822,0.0055,-1.347111E-018,0.001698279
+5823,0.005474761,-0.0003543433,0.001206771
+5824,0.005450237,-0.0007371526,0.001510754
+5825,0.005475476,-0.0003828094,0.002002263
+5826,0.003833078,-0.003944046,0.03065111
+5827,0.004437138,-0.003127698,0.03114516
+5828,0.003927612,-0.003849402,0.03156819
+5829,-0.004214666,-0.003527665,0.04274069
+5830,-0.00373647,-0.003957695,0.04380667
+5831,-0.004314376,-0.003410563,0.04408889
+5832,-0.00361757,-0.004142725,0.0006206733
+5833,-0.003435567,-0.004289138,0.001090389
+5834,-0.003825893,-0.003935397,0.001092613
+5835,0.005247698,0.00158915,0.005214218
+5836,0.005273295,0.001519764,0.004619262
+5837,-0.00226996,0.00496758,0.002392217
+5838,-0.002680883,0.004799615,0.003004267
+5839,-0.001671769,0.005239542,0.002554753
+5840,-0.002082691,0.005071578,0.003166802
+5841,0.005419201,0.0009374825,0.04664594
+5842,0.005424778,0.0009019473,0.04718142
+5843,0.005460892,0.0004828232,0.04640057
+5844,0.005466468,0.000447288,0.04693605
+5845,0.005434565,0.0008454071,0.04768594
+5846,0.005466468,0.000447288,0.04748069
+5847,0.005475889,0.0003795862,0.0479611
+5848,0.005443985,0.0007777053,0.04816636
+5849,0.005347699,0.001239481,0.0480932
+5850,0.005285054,0.001522392,0.0485251
+5851,0.005223311,0.001711438,0.04795086
+5852,-0.003819978,0.00395696,0.009096213
+5853,-0.003400494,0.004296367,0.007916609
+5854,0.004943962,0.00239706,0.04897686
+5855,0.005156419,0.001877767,0.04900456
+5856,0.005094675,0.002066813,0.04843031
+5857,0.004804947,-0.002675823,0.03516916
+5858,0.004884683,-0.002515899,0.034652
+5859,0.005123531,-0.001850326,0.03517308
+5860,0.004167888,-0.003572008,0.009750205
+5861,0.004327072,-0.003394018,0.01041989
+5862,0.004627583,-0.002925551,0.009929419
+5863,-0.00543589,-0.0008183862,0.004600036
+5864,-0.00543231,-0.000846919,0.005842002
+5865,-0.005250067,-0.001555232,0.004886829
+5866,-0.001421536,0.005254802,0.02509481
+5867,-0.001770413,0.00506384,0.02646097
+5868,-0.003129284,0.004521267,0.02563567
+5869,-0.002780407,0.004712229,0.02426952
+5870,-0.00472813,-0.002809533,0.04897507
+5871,-0.004947562,-0.00234954,0.04896174
+5872,-0.004841884,-0.002599061,0.04840441
+5873,-0.005061315,-0.002139068,0.04839108
+5874,-0.001188519,0.005369673,0.001159558
+5875,-0.0008912886,0.005413093,0.001759975
+5876,-0.001415892,0.005311095,0.001759413
+5877,0.003841723,0.003929497,0.04947966
+5878,-0.005471145,-0.0001688115,0.004763434
+5879,-0.005467565,-0.0001973442,0.0060054
+5880,-0.005462786,0.0006132989,0.005089084
+5881,0.0001668965,0.00547732,0.001623419
+5882,-0.0001235122,0.005496518,0.001097809
+5883,0.000401127,0.005475542,0.001049475
+5884,0.0006915357,0.005456344,0.001575085
+5885,0.00498274,-0.002321067,0.03049197
+5886,0.005237189,-0.001599785,0.03021507
+5887,0.001999945,0.005121041,0.04779742
+5888,0.001490986,0.005283779,0.04777787
+5889,0.001706572,0.005227014,0.04837667
+5890,0.001116742,0.00536924,0.04638625
+5891,0.001366306,0.005324337,0.04705439
+5892,0.001761691,0.005206736,0.04636054
+5893,0.005278408,-0.001491428,0.04759832
+5894,0.005394427,-0.001069887,0.04717175
+5895,0.004903623,-0.00247277,0.0475788
+5896,0.005100032,-0.00205546,0.04749646
+5897,0.005118568,0.002002885,0.001483497
+5898,0.005041079,0.002169111,0.00206507
+5899,0.005244636,0.001650042,0.001974277
+5900,0.0055,-1.347111E-018,0.007766056
+5901,0.0055,-1.347111E-018,0.008352902
+5902,0.005450585,-0.0005422617,0.008082837
+5903,0.0055,-1.347111E-018,0.001178177
+5904,0.0007092837,0.005453936,0.04707343
+5905,0.001114897,0.005300032,0.04311411
+5906,0.001646999,0.005226449,0.04384029
+5907,-0.004794904,-0.0026076,0.04486177
+5908,-0.005106113,-0.002043727,0.04544359
+5909,-0.005141372,-0.00194857,0.04447966
+5910,-0.000836499,0.005433143,0.003161113
+5911,-0.001106051,0.005366165,0.002379365
+5912,-0.0005814478,0.005468164,0.002379927
+5913,0.005384171,-0.001122264,0.0299306
+5914,-0.005328117,-0.001361094,0.04770777
+5915,0.00426798,-0.003467936,0.04848898
+5916,0.004384136,-0.00331031,0.04904985
+5917,0.004569315,-0.003060372,0.04852261
+5918,0.004926771,-0.002444311,0.03955497
+5919,0.004435966,-0.003164234,0.03997575
+5920,0.004969706,-0.002352079,0.04038863
+5921,0.004914527,-0.002469282,0.03100683
+5922,0.005168976,-0.001748,0.03072994
+5923,0.0055,-1.347111E-018,0.005557286
+5924,0.0055,-1.347111E-018,0.006108357
+5925,0.005451502,-0.0005372499,0.005856157
+5926,-0.004155671,0.0035949,0.005260044
+5927,-0.004136971,-0.003467636,0.03881791
+5928,-0.003361318,-0.004346946,0.03920417
+5929,0.002250645,0.005003231,0.04570061
+5930,0.002846831,0.004700717,0.04583584
+5931,0.002354221,0.004943313,0.0465438
+5932,0.004542469,-0.00304265,0.02650415
+5933,0.003989317,-0.00377835,0.02643853
+5934,0.004280186,-0.00345043,0.02575215
+5935,0.004393815,-0.003243638,0.03941057
+5936,0.003946263,-0.003827839,0.03988146
+5937,-0.005354493,0.001002825,0.009098319
+5938,-0.005257723,0.001576498,0.007986491
+5939,0.005263086,0.001553678,0.04542978
+5940,0.005286941,0.001428286,0.04595848
+5941,0.00512478,0.001992073,0.04606363
+5942,0.004730277,0.002787321,0.008187461
+5943,0.004380403,0.003306172,0.008937417
+5944,0.0042459,0.003448278,0.008043751
+5945,0.004745341,0.002754679,0.02243587
+5946,0.005038375,0.002196793,0.02272364
+5947,0.004716398,0.002812602,0.0231202
+5948,0.005009432,0.002254716,0.02340797
+5949,0.004741329,0.00271477,0.009262122
+5950,0.005103079,0.00205065,0.008958275
+5951,0.005110825,0.002030608,0.009493992
+5952,0.004653392,0.002897614,0.007607783
+5953,0.004169015,0.003558572,0.007464073
+5954,0.00466327,0.002877845,0.006990844
+5955,0.003324121,0.004317896,0.004615078
+5956,0.00394618,0.003831064,0.004954338
+5957,0.004012683,0.003760897,0.004270691
+5958,0.004622474,0.002945291,0.02367106
+5959,-0.004271638,0.003461676,0.04899611
+5960,-0.00442768,0.003259827,0.04950178
+5961,-0.004565501,0.003037384,0.04904236
+5962,-0.003097316,0.004525216,0.04225744
+5963,-0.002642252,0.004823182,0.0432103
+5964,-0.002031121,0.005066627,0.04242764
+5965,-0.005254156,-0.001614118,0.04834834
+5966,-0.005166894,-0.00188395,0.04893426
+5967,-0.005304972,-0.001395135,0.04893162
+5968,-0.003833998,-0.003873849,0.0134004
+5969,-0.0046041,-0.002950392,0.01364008
+5970,-0.004302448,-0.003426101,0.01252092
+5971,0.004692958,0.00285869,0.04895454
+5972,0.004794743,0.002693945,0.04946986
+5973,0.004317896,0.003399938,0.02158439
+5974,0.004270422,0.003453612,0.02221645
+5975,0.005393027,-0.001079226,0.02442917
+5976,0.005380047,-0.001141858,0.02384587
+5977,0.00521671,-0.001652571,0.02411928
+5978,-0.005275955,0.001302772,0.03550872
+5979,-0.00519013,0.001772445,0.03655437
+5980,-0.005477447,0.0004928517,0.03677806
+5981,-0.005391622,0.0009625246,0.0378237
+5982,0.001882718,0.005131049,0.003397679
+5983,0.002663783,0.004809299,0.003680818
+5984,0.00544912,-0.0005018094,0.02415961
+5985,-0.00141482,-0.005275126,0.02338702
+5986,-0.002430818,-0.004903707,0.02283372
+5987,-0.002604823,0.004789887,0.02843844
+5988,-0.001312449,0.005311823,0.02942374
+5989,-0.002589174,0.004800943,0.03010361
+5990,-0.004094084,0.003671032,0.04949433
+5991,0.005119407,-0.001845136,0.0213812
+5992,0.00494012,-0.00240311,0.02070157
+5993,0.004849319,-0.002594012,0.02146826
+5994,-0.003459722,0.004275137,0.0432587
+5995,-0.003004659,0.004573102,0.04421156
+5996,0.005220499,0.001695973,0.01970925
+5997,0.004894595,0.00244685,0.01967062
+5998,0.005210408,0.001721516,0.01915597
+5999,0.004884504,0.002472393,0.01911733
+6000,-0.004078438,-0.003674612,0.04788861
+6001,-0.003747042,-0.004021675,0.04796573
+6002,-0.003762936,-0.004007831,0.04726887
+6003,-0.003596116,-0.004090923,0.02076752
+6004,-0.002515132,-0.004869528,0.02145486
+6005,-0.003499172,-0.00419572,0.02220925
+6006,0.003649278,0.004114428,0.03030877
+6007,0.004183977,0.003472828,0.03035796
+6008,0.004084289,0.003623272,0.03088117
+6009,0.003360744,0.004337119,0.01222024
+6010,0.002521149,0.004733101,0.01151356
+6011,0.001630902,0.005251777,0.01200488
+6012,0.002470497,0.004855796,0.01271156
+6013,0.004799419,0.002633437,0.03315612
+6014,0.004712811,0.00275607,0.03369478
+6015,0.005092971,0.002075948,0.03349042
+6016,0.003934457,-0.003841761,0.01641035
+6017,0.003995887,-0.003773712,0.01698206
+6018,0.003240806,-0.004362323,0.01687778
+6019,0.004988093,-0.002292212,0.03577047
+6020,0.004555239,-0.003047898,0.03590113
+6021,0.003394545,0.004321127,0.03127789
+6022,0.004586467,-0.002983381,0.007781552
+6023,0.004260177,-0.003477495,0.007422049
+6024,0.004647563,-0.002838402,0.006857485
+6025,-0.003973102,-0.003799369,0.00047194
+6026,0.005389663,-0.001093318,0.0449649
+6027,0.005447654,-0.0005579759,0.04523661
+6028,0.005447654,-0.0005579759,0.04463646
+6029,0.005074907,0.002120215,0.03404927
+6030,0.0003445647,0.005478741,0.04892379
+6031,0.0008867815,0.005421835,0.04894896
+6032,0.004127728,-0.003622099,0.008048423
+6033,0.004566909,-0.003021552,0.008362828
+6034,0.002502209,-0.004893047,0.009241675
+6035,0.001269629,-0.005264214,0.009870485
+6036,0.001581995,-0.005223761,0.008598841
+6037,0.003147528,-0.004503404,0.04852619
+6038,0.003534269,-0.004209676,0.04847787
+6039,0.003328079,-0.00437852,0.04903527
+6040,-0.005235268,-0.001455702,0.006089065
+6041,-0.005053025,-0.002164015,0.005133892
+6042,0.00420389,0.003501239,0.04035488
+6043,0.004282802,0.003379869,0.03981409
+6044,0.003730045,0.004040837,0.03984104
+6045,0.005422216,0.0006787158,0.04891986
+6046,0.005327667,0.001359747,0.04902512
+6047,0.005390312,0.001076835,0.04859321
+6048,-0.002397749,-0.004939314,0.04269589
+6049,-0.003467494,-0.004177069,0.04235946
+6050,-0.002989299,-0.004607099,0.04342544
+6051,0.005476576,0.0003741581,0.001471571
+6052,0.005476576,0.0003741581,0.001991674
+6053,0.002504901,-0.004877026,0.04299571
+6054,0.002620701,-0.004826307,0.04203508
+6055,-0.0003472663,0.005489013,0.01318059
+6056,0.0005809521,0.005404485,0.01389694
+6057,0.0006104664,0.005396511,0.01251983
+6058,0.001519271,0.005282201,0.01322698
+6059,-0.004714978,0.002825502,0.04954058
+6060,0.005337912,0.001296021,0.04758867
+6061,0.005192765,0.001809691,0.0473945
+6062,0.005475889,0.0003795862,0.04849301
+6063,0.004492067,-0.003126153,0.04344343
+6064,0.004927514,-0.00243502,0.04381705
+6065,0.004944613,-0.002403093,0.04441912
+6066,0.00453013,-0.003091197,0.04404439
+6067,0.002326722,0.0048968,0.01902159
+6068,0.001581033,0.00526784,0.01972576
+6069,0.001549047,0.005277305,0.01888376
+6070,-0.005034593,-0.001978675,0.006951109
+6071,-0.005317013,-0.001356325,0.007859109
+6072,-0.005436543,-0.0008236542,0.006701431
+6073,0.003784878,-0.003986938,0.01049256
+6074,0.003242919,-0.004373785,0.009604652
+6075,0.001585539,-0.00522178,0.005237787
+6076,0.002467635,-0.004903125,0.004796989
+6077,0.00524687,-0.001594407,0.005815485
+6078,0.005253318,-0.001563311,0.00526278
+6079,0.005050205,-0.002165117,0.005447212
+6080,0.003589255,0.004156006,0.00707809
+6081,0.003590554,0.004154995,0.008075407
+6082,0.00294385,0.004611941,0.006407455
+6083,0.002945149,0.00461093,0.007404772
+6084,0.005006226,-0.00225884,0.008371621
+6085,0.004962431,-0.00236408,0.008967501
+6086,0.00511302,0.002025307,0.009964681
+6087,0.005257656,0.001540927,0.009717084
+6088,0.005252841,0.001565449,0.01026768
+6089,0.002681437,-0.004784727,0.007818141
+6090,0.005235868,0.001623889,0.01249561
+6091,0.002791495,-0.004673324,0.0146122
+6092,0.002362184,-0.004955589,0.01540851
+6093,0.00370301,-0.004064117,0.01420018
+6094,0.003296753,-0.004348627,0.01500713
+6095,0.005025784,-0.002220669,0.007790345
+6096,-0.005410972,0.0004997125,0.007884051
+6097,0.0055,-1.347111E-018,0.04435118
+6098,0.0055,-1.347111E-018,0.04495133
+6099,-0.002013328,0.005106531,0.04829863
+6100,-0.002500785,0.004896615,0.04826628
+6101,-0.002250299,0.005017259,0.04887615
+6102,0.005242071,-0.001614978,0.02657962
+6103,0.005405416,-0.0009997935,0.02663934
+6104,-0.0003114999,-0.005478062,0.02267785
+6105,-0.0001743484,-0.005474077,0.02403601
+6106,-0.004244839,0.003433534,0.0208641
+6107,-0.003837253,0.003746534,0.01970975
+6108,-0.004753042,0.002754517,0.0197814
+6109,0.005045456,-0.002175245,0.02570066
+6110,0.005029336,-0.002207477,0.02629634
+6111,0.005243388,-0.001609013,0.02601361
+6112,-0.00541129,0.0008847396,0.006251415
+6113,-0.005431517,0.00007554667,0.006856923
+6114,0.004178008,0.003526685,0.03846398
+6115,0.004302007,0.003402641,0.03773413
+6116,0.005177283,0.001848466,0.003100301
+6117,0.005151786,0.001923418,0.003669188
+6118,0.004954172,-0.00238848,0.02501669
+6119,0.005384023,-0.001054383,0.04910293
+6120,0.005475096,-0.0003857512,0.04894931
+6121,0.005446035,-0.0007658286,0.04866809
+6122,0.005288137,-0.001511339,0.04911337
+6123,0.002703991,-0.004787763,0.001515737
+6124,0.003142239,-0.004500164,0.001454537
+6125,0.002924137,-0.00463966,0.001029081
+6126,0.003362385,-0.00435206,0.0009678808
+6127,0.004645547,0.002926906,0.03127426
+6128,0.004745235,0.002776462,0.03075105
+6129,-0.004505612,-0.00315424,0.04733333
+6130,-0.004353449,-0.003352355,0.04674726
+6131,-0.004636805,-0.002950889,0.04660473
+6132,-0.0008027844,-0.005435312,0.0494657
+6133,0.003015756,-0.004495673,0.03201947
+6134,0.003937413,-0.003839652,0.03229152
+6135,0.003005955,-0.004505423,0.03129615
+6136,-0.003971162,-0.003754342,0.04576145
+6137,-0.004316011,-0.003404729,0.04592494
+6138,-0.004348185,-0.0033656,0.04508514
+6139,-0.000312061,-0.005487495,0.04947816
+6140,0.005475096,-0.0003857512,0.04955701
+6141,0.00132633,-0.005288162,0.03222378
+6142,0.002469059,-0.004899818,0.0324678
+6143,0.00219976,-0.005039853,0.03151185
+6144,0.005454084,0.0005228631,0.006371453
+6145,0.005395186,0.001062328,0.006107612
+6146,0.005454084,0.0005228631,0.005820381
+6147,0.003521339,-0.004221193,0.04949791
+6148,0.005397385,-0.001053573,0.005531545
+6149,0.005396146,-0.001060427,0.00609795
+6150,0.003299202,-0.004280807,0.02579395
+6151,-0.004708361,-0.002842711,0.007433163
+6152,-0.004168131,-0.003542553,0.006989609
+6153,-0.003906853,-0.003721099,0.008111229
+6154,0.005391474,-0.001082688,0.008358752
+6155,0.00318138,-0.004454054,0.03687193
+6156,0.004022156,-0.003719855,0.03674168
+6157,0.00386832,-0.003900509,0.03754077
+6158,0.005453072,0.0005285496,0.006931362
+6159,0.005394174,0.001068015,0.006667522
+6160,0.001224413,-0.005361935,0.04952784
+6161,0.00544912,-0.0005018094,0.02357725
+6162,0.0055,-1.347111E-018,0.0487846
+6163,0.005452741,-0.0005303957,0.005289752
+6164,-0.00355907,-0.004192991,0.04852065
+6165,-0.003359432,-0.004346247,0.04792516
+6166,0.004276137,0.003447245,0.006702849
+6167,0.004527762,-0.003097074,0.03708488
+6168,0.001158115,0.005376535,0.000463424
+6169,0.003944063,-0.003808948,0.01116224
+6170,0.0055,-1.347111E-018,0.02721434
+6171,0.0055,-1.347111E-018,0.02784536
+6172,0.003933861,-0.003817116,0.01333392
+6173,0.004029546,-0.003730424,0.01260907
+6174,0.004486381,-0.003140691,0.01307443
+6175,0.0007438211,0.005385579,0.00926278
+6176,0.005017199,0.002237168,0.03719766
+6177,0.005232895,0.001649284,0.03746138
+6178,0.005226667,0.001665257,0.03688998
+6179,0.005468558,0.0004332016,0.002482379
+6180,0.0055,-1.347111E-018,0.002218382
+6181,0.005389016,0.001089284,0.03716457
+6182,0.0009912744,0.005380997,0.005897157
+6183,-0.00006574441,0.005483968,0.004904443
+6184,-0.0002600323,0.005461835,0.006340251
+6185,0.005452953,0.0005292134,0.03355683
+6186,0.005452953,0.0005292134,0.03409358
+6187,0.005416554,0.0009542696,0.0338377
+6188,0.005462371,-0.0004736667,0.002508923
+6189,0.005432239,-0.00084575,0.002153582
+6190,0.005373579,0.001154171,0.03439328
+6191,0.005370901,0.001168902,0.03495776
+6192,0.005450275,0.000543945,0.03465805
+6193,0.002644913,-0.004787563,0.003904536
+6194,0.003725056,0.004012889,0.008969073
+6195,0.005433946,-0.0006260675,0.03799971
+6196,0.005364546,-0.00121103,0.03829471
+6197,0.005433946,-0.0006260675,0.03856199
+6198,-0.004073394,0.003615889,0.04416191
+6199,-0.004721555,0.002793841,0.04437655
+6200,-0.004546787,0.003094618,0.04324105
+6201,0.00518385,-0.001746596,0.006379025
+6202,0.003992494,-0.00377587,0.04737903
+6203,-0.0009052734,0.005346078,0.03923941
+6204,-0.0001775368,0.005496046,0.03833209
+6205,-0.002237749,0.005012771,0.03883226
+6206,-0.001505214,0.005217438,0.03795694
+6207,0.004244378,-0.003497481,0.04949413
+6208,0.00452274,-0.00312962,0.04955572
+6209,0.005384785,-0.001119777,0.0400016
+6210,0.005373812,-0.001170597,0.03945259
+6211,0.005435747,-0.0006175691,0.03973831
+6212,0.005188994,-0.001742003,0.00923944
+6213,0.005391131,-0.001085216,0.009465622
+6214,0.005243068,-0.00161031,0.009913299
+6215,0.004314164,0.003401807,0.009512389
+6216,-0.002973812,-0.004615113,0.04544693
+6217,-0.003444508,-0.004283197,0.0454436
+6218,-0.003243625,-0.004441588,0.04448507
+6219,0.002630393,0.004830212,0.04488743
+6220,0.001875054,0.005116329,0.04481594
+6221,0.000110814,0.005497469,0.04836638
+6222,-0.004200123,-0.003532875,0.002488745
+6223,-0.004288766,-0.003402329,0.003237446
+6224,-0.004625157,-0.002961708,0.002494764
+6225,-0.0047138,-0.002831162,0.003243465
+6226,0.00531536,-0.00137312,0.002261352
+6227,0.005333357,-0.001264523,0.001618524
+6228,0.003479524,0.004259392,0.002962541
+6229,0.003112018,0.004514413,0.003885104
+6230,0.00380058,0.003957414,0.003540716
+6231,-0.004946827,0.002393964,0.04951036
+6232,-0.004842341,0.002607676,0.04905095
+6233,-0.003252128,0.004366058,0.009850931
+6234,-0.00237857,0.004955709,0.009663981
+6235,-0.002555,0.004870519,0.0110164
+6236,0.004592995,0.003019333,0.004010933
+6237,0.004361179,0.003298482,0.004748679
+6238,0.004244499,0.003481748,0.003532945
+6239,0.002992463,-0.004563089,0.0378804
+6240,-0.00294642,0.004546612,0.008909263
+6241,-0.002073519,0.005090874,0.008618403
+6242,0.0055,-1.347111E-018,0.02658332
+6243,0.001305807,-0.005282327,0.0277168
+6244,0.002382271,-0.004951962,0.02677737
+6245,0.002523868,-0.004872076,0.02795275
+6246,-0.005165322,-0.001876397,0.009515546
+6247,-0.004683907,-0.002790232,0.01013924
+6248,-0.004990781,-0.00222036,0.008341163
+6249,-0.004509366,-0.003134196,0.008964859
+6250,0.0006372786,0.005367953,0.01034332
+6251,-0.0006359767,0.005459771,0.01095239
+6252,-0.0009086642,-0.005404846,0.003971203
+6253,-0.001592421,-0.005261409,0.004142335
+6254,-0.001504684,-0.00528291,0.005051034
+6255,0.001596356,-0.00514433,0.02609363
+6256,0.0005198917,-0.005474695,0.02703306
+6257,0.001180965,-0.005353494,0.004187664
+6258,0.0008228368,-0.00543796,0.005215876
+6259,-0.002908941,-0.004656806,0.003781394
+6260,-0.003431617,-0.004280668,0.003822884
+6261,-0.002976743,-0.004618865,0.004594502
+6262,-0.002527593,0.004840629,0.007625749
+6263,-0.005363113,-0.0002756483,0.01779935
+6264,-0.005425973,0.0008907187,0.01887235
+6265,-0.005383915,0.001120502,0.01740777
+6266,-0.005484876,0.00007001506,0.02168869
+6267,-0.00546411,0.0002567176,0.02030274
+6268,-0.005347127,-0.00109634,0.02071846
+6269,-0.00004516252,-0.005444789,0.03614052
+6270,0.0055,-1.347111E-018,0.03883028
+6271,0.005435747,-0.0006175691,0.03916043
+6272,-0.0007900602,-0.00532665,0.02641061
+6273,-0.001075562,-0.005332466,0.02747535
+6274,-0.002102509,-0.005069809,0.02662617
+6275,0.005049046,0.002177869,0.01386034
+6276,0.004636653,0.002889665,0.01358175
+6277,0.0002343902,-0.005480511,0.0280978
+6278,-0.003581322,-0.004173542,0.04947276
+6279,-0.00393478,-0.003841296,0.04952805
+6280,-0.003751499,-0.004007967,0.04900081
+6281,0.002851124,-0.00455895,0.02224822
+6282,-0.005069129,-0.001972984,0.03555204
+6283,-0.004646926,-0.002938265,0.03513279
+6284,-0.005110467,-0.001770459,0.03449355
+6285,-0.004947575,0.002392229,0.0485642
+6286,-0.004730772,0.00279156,0.04855231
+6287,-0.003153089,-0.004504679,0.007745537
+6288,-0.003217686,-0.004460367,0.008949058
+6289,0.0003504578,-0.005488745,0.04003469
+6290,-0.00003030815,-0.00548178,0.03890856
+6291,0.001116121,-0.005321263,0.03959524
+6292,-0.001381138,-0.005304059,0.03650313
+6293,0.003031288,0.004554278,0.002758255
+6294,0.00249986,-0.00488477,0.04781851
+6295,0.003008417,-0.004601568,0.04726823
+6296,-0.005480861,0.0003942364,0.009947104
+6297,-0.005440732,0.0007941688,0.01129656
+6298,-0.005245701,0.001463554,0.01006703
+6299,-0.00540125,-0.0009096494,0.01922974
+6300,0.0004795308,-0.005468587,0.004327389
+6301,0.004863947,0.002529229,0.01024332
+6302,0.005120955,0.00200432,0.01052685
+6303,-0.005307883,0.001308589,0.00511156
+6304,-0.00451106,0.003132723,0.004219927
+6305,-0.004696746,0.00278687,0.005183247
+6306,0.003287628,-0.00436956,0.04339129
+6307,0.004024356,-0.003737019,0.04378234
+6308,0.001985974,0.005128871,0.03978555
+6309,0.002800966,0.004607671,0.04029543
+6310,0.002005913,0.005120941,0.04076503
+6311,-0.004769906,0.002728346,0.003328918
+6312,-0.004955592,0.002382492,0.004292237
+6313,0.002915592,-0.004606071,0.01321406
+6314,0.003011277,-0.004519379,0.0124892
+6315,0.002043885,-0.005104958,0.02868121
+6316,0.0009724686,-0.005303142,0.02906222
+6317,0.00200427,-0.005108409,0.04899792
+6318,0.001766072,-0.005208006,0.04853515
+6319,0.001489115,-0.005289628,0.04898848
+6320,-0.005208095,-0.001731281,0.01080241
+6321,-0.005369559,-0.00115186,0.01193555
+6322,-0.005380564,-0.0004799897,0.01105345
+6323,0.0006985869,-0.005454166,0.04947461
+6324,0.001006661,-0.005402456,0.04900246
+6325,0.005379377,0.001126612,0.02720329
+6326,0.00545573,0.0005134766,0.02688843
+6327,0.005406733,-0.0009938285,0.02607333
+6328,0.005464841,-0.0004579517,0.02632482
+6329,0.005443907,-0.0005774171,0.02525591
+6330,0.005464841,-0.0004579517,0.02578807
+6331,0.0055,-1.347111E-018,0.02550982
+6332,0.005260714,-0.001445697,0.04648684
+6333,0.005443575,-0.0005791092,0.03686533
+6334,0.005462741,-0.0004713431,0.03633667
+6335,0.0055,-1.347111E-018,0.03660357
+6336,-0.005037067,0.002003103,0.04629282
+6337,-0.005315372,0.001378806,0.04632782
+6338,-0.004792564,0.00269537,0.04663055
+6339,-0.005070869,0.002071073,0.04666555
+6340,-0.001210265,-0.005326225,0.03795784
+6341,0.0001257102,-0.005466955,0.03759522
+6342,-0.0009114112,0.005389356,0.04250383
+6343,-0.0008294991,-0.005333191,0.03908397
+6344,-0.0009360688,-0.00529433,0.04049665
+6345,0.002465476,-0.004901027,0.03726752
+6346,0.00130874,-0.005291793,0.03749735
+6347,0.002261099,-0.005010577,0.03826876
+6348,0.005385799,-0.001113294,0.02554117
+6349,-0.005182189,-0.001820077,0.04343708
+6350,-0.005398236,-0.0008468196,0.04327952
+6351,-0.005286561,-0.001517313,0.04220954
+6352,0.005298083,0.001475585,0.001453917
+6353,0.005343351,0.001298439,0.0009272843
+6354,-0.002488959,0.004904461,0.004154982
+6355,-0.004865467,-0.002349799,0.04263799
+6356,-0.004827797,-0.002397529,0.04139503
+6357,-0.004176995,-0.003575395,0.04149774
+6358,0.002069826,0.005095228,0.04282941
+6359,0.0009847231,0.005289198,0.0423554
+6360,-0.004761095,-0.002652563,0.04386552
+6361,0.003336996,-0.004302102,0.03373771
+6362,0.00417386,-0.003573886,0.03386337
+6363,0.003725748,-0.004030849,0.03457933
+6364,-0.005400927,-0.0009837299,0.03593183
+6365,-0.005411052,-0.0008729348,0.03482985
+6366,-0.005468634,0.00001987381,0.03587355
+6367,-0.005478759,0.000130669,0.03477157
+6368,-0.003375994,-0.004324647,0.006629904
+6369,-0.003248861,-0.004403584,0.005636597
+6370,-0.003845032,-0.003921859,0.005895266
+6371,-0.0008344055,0.005346243,0.04050372
+6372,-0.001973519,0.005133207,0.04017388
+6373,0.005392388,-0.001082337,0.02499169
+6374,0.005657174,-0.0008132058,0.02992607
+6375,0.00572391,-0.0001839515,0.02966277
+6376,0.005667962,-0.0007606289,0.02935563
+6377,-0.004871279,-0.002454028,0.04669906
+6378,-0.005145051,-0.001942528,0.04645856
+6379,-0.004910577,-0.00243939,0.04636423
+6380,-0.005289199,-0.001385349,0.04626988
+6381,-0.005324457,-0.001290192,0.04530595
+6382,-0.005357419,-0.0009753129,0.0443221
+6383,-0.004460716,0.003152604,0.04725299
+6384,-0.004392956,0.003226981,0.04652973
+6385,-0.003568092,0.004179629,0.04890003
+6386,-0.003408919,0.004316053,0.04827559
+6387,-0.003829925,0.003943962,0.04828344
+6388,-0.002578638,0.004858044,0.04511171
+6389,-0.002351452,0.004966933,0.04605529
+6390,-0.001999109,0.005092584,0.04537709
+6391,-0.001845938,-0.00518051,0.03914516
+6392,0.00006943956,0.005497196,0.03935205
+6393,-0.003735217,0.004034626,0.01089172
+6394,-0.004152054,0.003565228,0.01005013
+6395,0.004873877,-0.00254802,0.02688057
+6396,0.004611594,-0.0029558,0.02612857
+6397,0.005452813,0.0005299972,0.01255505
+6398,0.005452813,0.0005299972,0.01305337
+6399,0.005396921,0.00105567,0.01278348
+6400,0.002836914,-0.004623684,0.02027797
+6401,0.001152721,-0.005306617,0.03881068
+6402,0.002224499,-0.005025223,0.03905331
+6403,0.004211808,0.003458457,0.01149608
+6404,0.004058711,0.003678083,0.01201233
+6405,-0.00516994,-0.001866739,0.01968691
+6406,-0.005224063,-0.001680049,0.01819819
+6407,0.005446975,-0.0005121647,0.02304165
+6408,0.005377903,-0.001152214,0.02331026
+6409,-0.003927981,0.003836204,0.04895632
+6410,-0.003751363,0.004021873,0.049462
+6411,0.004335244,0.003339665,0.02846977
+6412,0.00460823,0.003001456,0.02776944
+6413,0.004818085,0.002622042,0.02833756
+6414,-0.005250689,-0.001178884,0.02940899
+6415,-0.004810141,-0.00261459,0.03000529
+6416,-0.004819144,-0.002601419,0.0287861
+6417,0.00505749,0.002138812,0.04519456
+6418,0.005030967,0.0022091,0.04459151
+6419,0.005236563,0.001623966,0.04482673
+6420,-0.003840588,0.003935926,0.003440431
+6421,-0.004055373,0.003687938,0.002765464
+6422,-0.003675591,0.00408853,0.002772438
+6423,0.0055,-1.347111E-018,0.004560639
+6424,0.005688167,0.0006065129,0.0002899747
+6425,0.005666194,0.0007141323,0.000757939
+6426,0.005738313,0.00006028908,0.000879063
+6427,0.005427881,0.0006538432,0.001057053
+6428,0.004775921,-0.002726536,0.0004794699
+6429,0.004900738,-0.002473483,0.0009843361
+6430,0.004633621,-0.002958311,0.0009994452
+6431,0.004651621,0.002892147,0.03618326
+6432,0.004496852,0.003162871,0.03549692
+6433,0.004247988,-0.003480429,0.002244148
+6434,-0.004649411,0.002851274,0.01611596
+6435,-0.004745036,0.002371386,0.0174673
+6436,-0.004192172,0.003549837,0.01724333
+6437,-0.003548174,0.004151951,0.04687236
+6438,-0.00323622,0.004439316,0.04755734
+6439,-0.004794141,0.00260696,0.01230995
+6440,-0.005130397,0.001981815,0.01361767
+6441,-0.004825604,0.002552154,0.01473842
+6442,-0.004489347,0.003177299,0.0134307
+6443,-0.004408831,0.003286643,0.01587804
+6444,-0.005277017,0.001307225,0.03898605
+6445,-0.004945798,0.002373181,0.03898841
+6446,-0.005060402,0.002028481,0.03782607
+6447,-0.004841893,0.00260655,0.02121564
+6448,-0.005196363,0.001561607,0.0201397
+6449,0.0055,-1.347111E-018,0.0216315
+6450,0.005442386,-0.0005336223,0.02137335
+6451,0.0055,-1.347111E-018,0.02218257
+6452,0.005442386,-0.0005336223,0.02192442
+6453,-0.003789841,0.003970068,0.001487565
+6454,-0.003933291,0.00379733,0.002071169
+6455,-0.004198263,0.003548448,0.001274368
+6456,-0.004341714,0.00337571,0.001857972
+6457,0.001976572,-0.005128363,0.02281954
+6458,0.002954464,-0.004516118,0.02300865
+6459,0.003829016,-0.003946705,0.02243733
+6460,0.005367194,-0.001200925,0.01441458
+6461,0.005431018,-0.0006396358,0.01470381
+6462,0.005440318,-0.0005954239,0.01411924
+6463,0.005376494,-0.001156714,0.01383001
+6464,-0.004178773,-0.003554215,0.02135705
+6465,-0.004878422,-0.002393428,0.02079883
+6466,-0.004440402,-0.003098186,0.02258924
+6467,-0.005140051,-0.001937399,0.02203101
+6468,0.005404631,0.001013443,0.004984014
+6469,0.002457107,0.004786839,0.02877148
+6470,0.001209185,0.005364127,0.02870205
+6471,0.001686276,0.005224342,0.02970191
+6472,-0.005055087,0.00215965,0.02640177
+6473,-0.005330915,0.0008015156,0.02626124
+6474,-0.00522174,0.001324315,0.02529624
+6475,-0.005497568,-0.00003381958,0.02515571
+6476,0.004935549,-0.002425615,0.02397431
+6477,0.004360739,-0.003246388,0.02374301
+6478,0.004878714,-0.002539097,0.02326755
+6479,-0.005397843,0.001020184,0.02139673
+6480,-0.005059515,0.001641446,0.02384264
+6481,-0.004791548,0.002663336,0.02516437
+6482,-0.005489708,0.0003024249,0.02397451
+6483,0.005246782,0.001570712,0.03635172
+6484,-0.0052778,-0.0007710445,0.02300125
+6485,-0.005418609,0.0008334817,0.02278269
+6486,0.003604693,0.004153478,0.03665645
+6487,0.0003479721,0.005361792,0.03047633
+6488,-0.0009028252,0.005424588,0.03043872
+6489,0.001265482,0.005336999,0.03159144
+6490,0.00003745466,0.005417085,0.03153061
+6491,-0.005341501,0.000003748971,0.01674315
+6492,-0.005379431,-0.001103597,0.01544569
+6493,-0.005320698,-0.001392401,0.01713473
+6494,0.003381287,-0.004310135,0.04433818
+6495,0.00259856,-0.004817601,0.0439426
+6496,0.002708481,-0.004769627,0.04492753
+6497,-0.002408995,-0.00488473,0.03831916
+6498,-0.003571794,-0.004152779,0.03811139
+6499,-0.003532137,-0.004180005,0.03704091
+6500,-0.002369337,-0.004911955,0.03724869
+6501,0.00173177,0.005202296,0.004208925
+6502,0.0009122562,0.005401221,0.003724406
+6503,0.000917233,0.005400874,0.004606507
+6504,0.005188372,0.0005574934,0.0002899747
+6505,0.00537794,0.001151048,0.0004679643
+6506,0.005238313,0.00006028908,0.000879063
+6507,-0.005401559,-0.0007550808,0.04111375
+6508,-0.005376573,-0.000300964,0.04223976
+6509,0.004947629,-0.002402106,0.0169005
+6510,0.00459119,-0.002938038,0.01718841
+6511,0.004352326,-0.00323778,0.01669415
+6512,-0.004957788,0.002374698,0.03532743
+6513,0.003131606,-0.004432512,0.02994089
+6514,-0.003886678,-0.00388812,0.003093608
+6515,-0.004077787,-0.003665685,0.004075223
+6516,-0.004479875,-0.003179894,0.004219062
+6517,-0.004833318,-0.002610722,0.006338743
+6518,-0.004423636,-0.003223503,0.006332832
+6519,-0.004628767,-0.002909376,0.00511142
+6520,-0.004219084,-0.003522158,0.00510551
+6521,-0.004567235,-0.002922729,0.0188034
+6522,0.004568623,-0.003019556,0.033388
+6523,0.004558859,-0.003038018,0.03280451
+6524,0.004121919,-0.003627422,0.03310108
+6525,-0.005399208,0.000251719,0.03260342
+6526,-0.005233028,0.001616658,0.03279571
+6527,-0.005424201,0.0004716395,0.03370153
+6528,0.00518823,-0.001745466,0.008686769
+6529,0.005392238,-0.001079226,0.008911423
+6530,0.005458508,0.000497223,0.005264382
+6531,0.005400207,0.001039083,0.005540013
+6532,0.00287724,0.00466593,0.0325653
+6533,0.002531791,0.004807335,0.03177059
+6534,0.003504751,0.004219995,0.03207083
+6535,0.004621294,0.002975017,0.02429767
+6536,0.003964007,0.003749938,0.02402763
+6537,-0.005497046,0.000149903,0.03023364
+6538,-0.005466193,-0.0002604116,0.03139183
+6539,-0.005219836,-0.001589199,0.03056718
+6540,-0.002096775,-0.005062923,0.02932198
+6541,-0.003116061,-0.004491943,0.030051
+6542,-0.003199272,-0.004418204,0.0287153
+6543,0.004889082,-0.002517981,0.01559515
+6544,0.004890781,-0.002514539,0.0161615
+6545,0.005174715,-0.001739324,0.01642801
+6546,0.005173016,-0.001742765,0.01586167
+6547,0.002512834,0.004880546,0.004492065
+6548,0.002623439,0.004829557,0.005398937
+6549,-0.003060872,0.004567744,0.03241968
+6550,-0.00217955,0.004913708,0.03111859
+6551,-0.001101425,0.005387821,0.03205042
+6552,-0.001982747,0.005041857,0.03335151
+6553,-0.00390394,0.003665787,0.03302226
+6554,-0.003100023,0.0045398,0.03418009
+6555,-0.003275821,0.004338379,0.01704311
+6556,-0.003406235,0.004261453,0.0181926
+6557,0.005156264,-0.001779293,0.02360254
+6558,0.005277392,0.00149995,0.004048271
+6559,0.002944255,0.004607776,0.02142981
+6560,0.002914824,0.00463065,0.02243746
+6561,-0.002521446,-0.00482522,0.04480707
+6562,-0.002880537,0.004552492,0.04021613
+6563,-0.003144767,0.004432057,0.03887451
+6564,-0.00388473,0.003893423,0.0400155
+6565,0.005251005,0.001526443,0.0186039
+6566,0.005102903,0.0020519,0.01856786
+6567,0.005259687,0.001504509,0.01805063
+6568,0.005111585,0.002029966,0.01801458
+6569,0.001785826,-0.005174903,0.04157597
+6570,0.0008700475,-0.005406817,0.04107851
+6571,0.0006399511,-0.005409557,0.04206818
+6572,0.003927329,-0.003730513,0.00342608
+6573,0.004430386,-0.003253174,0.003857584
+6574,0.004500312,-0.003161066,0.002995076
+6575,0.00543074,0.000866397,0.002746837
+6576,0.005344795,0.001264184,0.002368246
+6577,0.003672922,0.004082125,0.002324318
+6578,0.003923876,0.003853985,0.001638336
+6579,0.004136603,0.003612807,0.002224737
+6580,0.005399423,-0.00102244,0.001074548
+6581,-0.0008813157,0.005418636,0.03432905
+6582,-0.001998592,0.004916578,0.03515764
+6583,-0.0006790068,0.005455958,0.03574149
+6584,0.0055,-1.347111E-018,0.01722367
+6585,0.0055,-1.347111E-018,0.01670132
+6586,0.005456115,0.0005112548,0.0169489
+6587,0.003728967,-0.004041989,0.01180174
+6588,0.004340483,-0.003279652,0.01189542
+6589,0.005422029,0.0009226809,0.0177647
+6590,0.005421184,0.0009275401,0.01832164
+6591,-0.005418476,0.0009358072,0.04949905
+6592,-0.005359197,0.001173912,0.04901165
+6593,-0.005309705,0.00142591,0.0495126
+6594,-0.00276635,-0.004725432,0.01420993
+6595,-0.001531817,-0.005235907,0.01417311
+6596,-0.002200989,-0.005036785,0.01494247
+6597,0.004710682,0.002813145,0.04435056
+6598,0.005024089,0.002226499,0.0439924
+6599,0.003904392,-0.003867463,0.03918052
+6600,0.004392094,-0.003245505,0.03848168
+6601,0.003902672,-0.00386933,0.03825162
+6602,0.005729138,0.0001643076,0.04971926
+6603,0.005678685,0.0007121879,0.04971926
+6604,0.005229138,0.0001643076,0.04971926
+6605,0.005181793,-0.001816416,0.04956744
+6606,-0.003124328,-0.00440573,0.01544199
+6607,0.002304483,-0.004993889,0.03058593
+6608,0.005048021,0.002173631,0.04249988
+6609,0.005045368,0.002179135,0.0415313
+6610,0.005234872,0.001634053,0.04196687
+6611,-0.004594671,-0.002962284,0.01519041
+6612,-0.005214333,-0.001545162,0.01441813
+6613,-0.004576494,0.003040052,0.03077722
+6614,-0.004653303,0.00290546,0.02927013
+6615,-0.004869192,0.002526712,0.03225166
+6616,-0.004946002,0.00239212,0.03074457
+6617,0.003863989,-0.003907129,0.001370618
+6618,0.003532625,-0.004211716,0.001478946
+6619,0.004750418,0.002692567,0.01827797
+6620,0.004818593,0.002594016,0.01772634
+6621,0.005406553,0.001006591,0.01725278
+6622,0.005456115,0.0005112548,0.01747125
+6623,0.005419307,0.0009381782,0.01888166
+6624,0.005465913,0.000411426,0.01857621
+6625,0.005453393,0.0005267521,0.01912496
+6626,0.0055,-1.347111E-018,0.01881951
+6627,0.002812313,0.00467139,0.008465206
+6628,0.002712557,0.004710827,0.009445749
+6629,0.001685903,0.005230741,0.009799333
+6630,0.001785658,0.005191304,0.008818791
+6631,0.002929847,0.004626935,0.03347759
+6632,0.003703212,0.004026258,0.03369985
+6633,0.003650605,0.004065254,0.03278756
+6634,-0.003232194,0.004448948,0.03113446
+6635,0.00522848,0.001687177,0.00045932
+6636,0.005172015,0.001828429,0.0009631378
+6637,0.002210816,-0.004989557,0.03650382
+6638,0.003188331,-0.004447838,0.03617343
+6639,0.002356846,-0.004942569,0.03568033
+6640,0.005236015,0.001643958,0.03920782
+6641,0.005388795,0.001088108,0.03949253
+6642,0.005386342,0.001098396,0.03889477
+6643,0.005233562,0.001654245,0.03861006
+6644,0.004627714,-0.002923568,0.0255329
+6645,-0.004255132,-0.003483383,0.04845371
+6646,-0.004418704,-0.00327171,0.04789915
+6647,0.005152466,-0.001796445,0.02300161
+6648,0.005374105,-0.001169365,0.02270933
+6649,0.0055,-1.347111E-018,0.02994414
+6650,0.005455282,0.0005160487,0.03022636
+6651,0.00545467,0.0005195408,0.03134892
+6652,0.005388393,0.001091376,0.03163961
+6653,0.005389005,0.001087884,0.0310771
+6654,0.005455282,0.0005160487,0.0307864
+6655,0.005449478,-0.0005482521,0.009745105
+6656,0.005377315,-0.001153139,0.01328792
+6657,0.005440318,-0.0005954239,0.01356817
+6658,0.005461506,-0.0004790432,0.01304108
+6659,0.005398503,-0.001036758,0.01276084
+6660,0.003416307,-0.004271379,0.007479739
+6661,0.002868188,-0.004689526,0.006803902
+6662,0.004773741,0.00272369,0.0107681
+6663,0.005030749,0.002198782,0.01105163
+6664,-0.00273706,0.004762704,0.03747737
+6665,-0.005168735,-0.001873233,0.004192565
+6666,-0.00496942,0.002347614,0.03368445
+6667,-0.005221397,0.001643743,0.03443868
+6668,0.005378571,-0.001147352,0.04326029
+6669,0.005440818,-0.00059295,0.04349966
+6670,0.005398629,-0.001037322,0.04273634
+6671,0.005444613,-0.0005233229,0.03465549
+6672,0.005444613,-0.0005233229,0.03528539
+6673,0.005385865,0.001101086,0.03049136
+6674,0.002576402,0.00481454,0.03566968
+6675,0.005051829,0.002162441,0.04094891
+6676,0.005241333,0.001617359,0.04138448
+6677,0.003827975,0.003909364,0.01841344
+6678,0.003361606,0.004350717,0.0189984
+6679,0.003158183,0.00448411,0.01823023
+6680,0.0055,-1.347111E-018,0.03106422
+6681,0.005392263,0.001073752,0.04330172
+6682,0.005455343,0.0005157013,0.04300879
+6683,0.005390042,0.00108632,0.04386545
+6684,0.005453122,0.0005282689,0.04357252
+6685,0.00161154,0.005248186,0.01531685
+6686,0.001622622,0.005245417,0.01414444
+6687,0.005012733,-0.002240267,0.04516889
+6688,0.004574535,-0.003013638,0.04495228
+6689,0.005055475,-0.002155161,0.04576729
+6690,0.005414109,0.0009678836,0.04276267
+6691,0.005223383,0.001669637,0.04361733
+6692,0.005245229,0.001563769,0.04307828
+6693,0.003990034,0.003686656,0.01913709
+6694,0.003559741,0.004190474,0.01966702
+6695,0.004536291,0.003107124,0.01942727
+6696,0.004105998,0.003610942,0.0199572
+6697,0.000712811,0.005411859,0.01603747
+6698,0.001739128,0.005195519,0.01618351
+6699,-0.001816841,0.005106853,0.036503
+6700,-0.0005779031,0.005463489,0.03691057
+6701,0.0003492742,-0.005488451,0.02567118
+6702,0.002821388,0.004680599,0.01554437
+6703,0.003672062,0.004070408,0.01684656
+6704,0.0031072,0.004524582,0.017345
+6705,0.002856974,0.004653397,0.01658003
+6706,0.004620129,-0.002938807,0.02873348
+6707,0.004321159,-0.003401489,0.02924343
+6708,0.003636476,0.004097609,0.0158109
+6709,0.00515821,-0.0009478055,0.03191758
+6710,0.005154883,-0.0009626273,0.03246574
+6711,0.005650351,-0.001037711,0.0319296
+6712,0.005374104,-0.001169924,0.03163394
+6713,0.005370778,-0.001184746,0.03218211
+6714,-0.001020369,-0.005351023,0.02882965
+6715,0.00501327,0.002255605,0.03584248
+6716,0.004858501,0.002526329,0.03515614
+6717,-0.005450012,0.000322959,0.04516101
+6718,-0.005482115,-0.0004177774,0.04514485
+6719,0.005386455,-0.001100906,0.01944215
+6720,0.005390128,-0.001085169,0.01887958
+6721,0.005251217,-0.001598032,0.01842971
+6722,0.004084418,-0.003679595,0.04901821
+6723,-0.0008510306,0.005431013,0.0242806
+6724,-0.0002559134,0.005432032,0.02341494
+6725,0.0004211068,0.005393311,0.0247444
+6726,0.004194495,0.003522139,0.03167411
+6727,0.00425885,0.003402502,0.03899444
+6728,0.00475463,0.002760106,0.03933457
+6729,0.004159086,0.003582131,0.01290891
+6730,0.002335172,-0.004968429,0.04006982
+6731,0.005679694,0.0003292165,0.02938992
+6732,0.00522391,-0.0001839515,0.02966277
+6733,0.005455784,0.000513168,0.02967129
+6734,-0.005468165,0.0003308834,0.04104528
+6735,-0.005367545,0.0007382949,0.04000843
+6736,-0.005466513,-0.0004665483,0.0400215
+6737,-0.003860559,0.003908172,0.0009645964
+6738,0.004586808,0.002991917,0.01414886
+6739,0.004999201,0.00228012,0.01442745
+6740,-0.005359731,0.00123419,0.0477621
+6741,-0.005316056,0.001399047,0.04842313
+6742,-0.005411951,0.0009080271,0.04836307
+6743,0.0001403075,0.005497361,0.04061637
+6744,0.001183873,0.005299423,0.04023135
+6745,0.000979611,0.005342283,0.04112686
+6746,-0.0000850119,0.005497289,0.04165092
+6747,0.003524777,0.004218424,0.02053892
+6748,0.004179655,0.003503512,0.02049625
+6749,0.001621907,-0.005237191,0.04362778
+6750,0.000591832,-0.005421125,0.04315936
+6751,0.005371308,-0.001182763,0.01497628
+6752,0.004464867,0.003205029,0.04772375
+6753,0.004696314,0.002857287,0.04716178
+6754,0.00476516,0.002729244,0.04776395
+6755,0.005127091,-0.001887554,0.01400727
+6756,0.004950784,0.002354379,0.04728162
+6757,0.00501963,0.002226336,0.04788379
+6758,0.004524296,0.003125364,0.04948468
+6759,-0.002267656,-0.005009546,0.04945706
+6760,0.005404721,-0.001004273,0.02774966
+6761,0.005408043,-0.0009717826,0.01835574
+6762,-0.005068156,0.002128856,0.00523397
+6763,0.005738313,0.00006028908,0.0002899747
+6764,0.005443907,-0.0005774171,0.02473244
+6765,0.004183772,-0.003569535,0.01394778
+6766,0.004570978,-0.0029741,0.01456055
+6767,0.003952921,-0.003816536,0.01481404
+6768,0.0055,-1.347111E-018,0.02329817
+6769,0.0055,-1.347111E-018,0.02388053
+6770,0.001875631,0.005139044,0.03351825
+6771,0.0009278297,0.005415239,0.001006422
+6772,0.005450268,0.0005439829,0.01359404
+6773,0.005450268,0.0005439829,0.01414511
+6774,0.00016061,0.00539175,0.02950695
+6775,0.0055,-1.347111E-018,0.01331886
+6776,0.0004808639,-0.005467277,0.04893459
+6777,0.0008110443,-0.005439869,0.04839596
+6778,-0.00524144,-0.001659472,0.04946828
+6779,-0.005377695,-0.001147336,0.04946334
+6780,0.005391983,0.00107787,0.01614807
+6781,0.005453041,0.0005287231,0.01581865
+6782,0.005388409,0.001093508,0.01557367
+6783,0.0055,-1.347111E-018,0.03940816
+6784,-0.005347717,-0.001115042,0.008795714
+6785,-0.005459985,-0.0006615385,0.04944121
+6786,-0.001571329,0.005230809,0.02353335
+6787,-0.002722375,0.004753169,0.02277153
+6788,-0.0009292379,0.005420246,0.02240852
+6789,-0.002080284,0.004942607,0.0216467
+6790,-0.002710526,0.004772064,0.04886988
+6791,-0.003000085,0.004609717,0.04817444
+6792,-0.002790343,0.004734268,0.04757083
+6793,0.00504058,0.002200566,0.049507
+6794,0.005217898,0.00172513,0.04949755
+6795,0.0055,-1.347111E-018,0.03560693
+6796,0.005462741,-0.0004713431,0.03583835
+6797,0.005407354,-0.000994666,0.03551681
+6798,-0.001159522,0.005361243,0.00651128
+6799,-0.0009652342,0.005383375,0.005075472
+6800,0.005443575,-0.0005791092,0.0374164
+6801,0.0055,-1.347111E-018,0.03770572
+6802,0.003354753,-0.004354566,0.003602425
+6803,0.003712593,0.00405634,0.04084647
+6804,0.005362051,-0.001221304,0.03773241
+6805,0.00537168,-0.001174346,0.0371491
+6806,-0.003367181,0.004348769,0.04943803
+6807,0.005241173,-0.00161732,0.02777459
+6808,0.002812883,0.004629145,0.01065855
+6809,0.003825382,0.003931206,0.01018188
+6810,0.003620491,0.004139469,0.01114942
+6811,-0.004320925,-0.003402435,0.0110148
+6812,-0.003820199,-0.003873464,0.009802688
+6813,-0.001972285,-0.005121401,0.01818654
+6814,-0.002870345,-0.004628836,0.01808792
+6815,-0.002315954,-0.004988451,0.01899906
+6816,0.003832928,-0.003944194,0.02933725
+6817,0.004141821,-0.003598908,0.02858568
+6818,0.005147694,-0.001936724,0.04806081
+6819,0.005266967,-0.001543333,0.04820586
+6820,0.005444299,-0.0007482312,0.0477028
+6821,0.005382986,-0.001121791,0.04777929
+6822,0.004029107,-0.003713639,0.03604317
+6823,0.005456087,-0.0006782254,0.04820505
+6824,0.005485148,-0.000298148,0.04795436
+6825,0.003645153,0.004116569,0.03802456
+6826,0.003706093,0.00406347,0.03902139
+6827,0.002885145,0.004586505,0.03852962
+6828,-0.004007125,-0.003699103,0.03059122
+6829,-0.003036758,-0.004532076,0.03141052
+6830,0.005374673,-0.001162001,0.03659485
+6831,0.005223152,-0.001680358,0.0361083
+6832,0.005393839,-0.001054235,0.0360662
+6833,-0.004045834,0.00372562,0.000534701
+6834,0.005403834,-0.001022477,0.004978841
+6835,0.005406055,-0.001009962,0.004422849
+6836,0.005219599,-0.001647664,0.004691946
+6837,-0.005287595,0.001507292,0.002485353
+6838,-0.00539146,0.00104754,0.001771279
+6839,-0.005421166,0.0007013998,0.002480956
+6840,-0.0002845373,-0.005456892,0.0249758
+6841,-0.00210798,-0.005073643,0.04563
+6842,-0.001738786,-0.005214835,0.04462579
+6843,0.003548756,-0.004126774,0.006853364
+6844,-0.00349248,0.004075186,0.01567782
+6845,-0.0039974,0.003721844,0.01459949
+6846,0.002093765,-0.005085613,0.01981433
+6847,0.0009659959,-0.005321206,0.01908348
+6848,0.0008847524,-0.005352051,0.01995268
+6849,0.0001665964,-0.00549051,0.01022107
+6850,0.001318086,-0.005241389,0.01078824
+6851,0.005395677,0.001058628,0.04222719
+6852,0.0000169217,-0.005395285,0.007972676
+6853,-0.001176025,-0.005372755,0.00821947
+6854,-0.0007678987,-0.005434533,0.006962336
+6855,0.0001696114,-0.005455643,0.007031304
+6856,0.00113626,-0.005377199,0.007005662
+6857,0.0009544318,-0.005416395,0.008041644
+6858,-0.004373018,0.003304418,0.000534701
+6859,0.0055,-1.347111E-018,0.04772079
+6860,0.005459151,-0.0004500832,0.04746922
+6861,0.005232025,-0.001640226,0.008090889
+6862,0.00003584011,-0.005499756,0.01946218
+6863,-0.0001550483,-0.00549228,0.02036769
+6864,0.003326641,0.004378667,0.0198703
+6865,0.002580953,0.004749708,0.02057446
+6866,0.003484453,0.004253382,0.02927137
+6867,0.002713623,0.004690885,0.0302018
+6868,0.005259803,0.001526408,0.04084418
+6869,0.005394774,-0.001051785,0.04828154
+6870,0.004868916,0.002556583,0.04843034
+6871,0.0007787662,-0.005409629,0.003434302
+6872,0.001038381,-0.005390886,0.00258973
+6873,0.005397812,0.001049065,0.02107559
+6874,0.005455235,0.000516318,0.0208166
+6875,0.005454405,0.0005210501,0.0213661
+6876,0.005396981,0.001053797,0.02162509
+6877,0.005363379,-0.001216766,0.02102579
+6878,0.005392776,-0.001061108,0.02052479
+6879,0.005184092,-0.00177474,0.02034617
+6880,0.004725977,0.002793029,0.03247987
+6881,0.005019529,0.00223554,0.03281417
+6882,0.004589202,0.003031351,0.04828815
+6883,0.004383549,0.003304601,0.03294536
+6884,0.001950575,-0.005089364,0.00654862
+6885,0.001792093,-0.005152347,0.007581168
+6886,0.004296942,0.003427233,0.03348402
+6887,-0.000819884,-0.005432002,0.0004951945
+6888,0.005233367,-0.00163413,0.007521349
+6889,-0.004330815,0.003370479,0.04791778
+6890,-0.00461259,0.002995009,0.04804981
+6891,-0.004742491,0.002777134,0.04738501
+6892,0.004913055,-0.002469044,0.03226455
+6893,0.004922819,-0.002450582,0.03284803
+6894,-0.004148522,0.003610887,0.04837017
+6895,-0.002358005,-0.004938751,0.00166142
+6896,-0.002071317,-0.005091473,0.001121018
+6897,0.005145648,-0.001845868,0.03256402
+6898,0.005148974,-0.001831046,0.03201586
+6899,-0.00315006,0.004462908,0.04522398
+6900,-0.002855312,0.004691133,0.04603396
+6901,-0.004826162,0.002580363,0.01005962
+6902,-0.003961022,0.003815221,0.04614328
+6903,0.001393515,0.005320385,0.003436749
+6904,0.001745245,0.005206981,0.03695916
+6905,-0.003348027,0.004302455,0.04104427
+6906,-0.002343835,0.004961525,0.0412449
+6907,-0.004924114,-0.002440808,0.001747662
+6908,-0.00466192,-0.002895707,0.001732587
+6909,-0.004795795,-0.002690982,0.001152996
+6910,-0.004862352,-0.002560339,0.0005183813
+6911,-0.003149815,-0.004443647,0.02737379
+6912,-0.004173238,-0.003496639,0.02673751
+6913,-0.004099339,-0.003612192,0.02803632
+6914,0.004971424,-0.002348692,0.04143404
+6915,0.004502306,-0.003088332,0.04192788
+6916,0.004981034,-0.002326866,0.04238504
+6917,-0.004760509,-0.002718234,0.04730883
+6918,0.004931763,-0.002434687,0.01485576
+6919,0.004528298,-0.003057394,0.01529994
+6920,-0.004652837,0.002850178,0.03650659
+6921,-0.00452311,0.003106215,0.03777829
+6922,0.003498643,-0.004190158,0.04503571
+6923,0.004089724,-0.003656431,0.04468913
+6924,-0.001401352,0.005311049,0.01622078
+6925,-0.001718603,0.005183444,0.01521181
+6926,-0.0006382284,0.00543325,0.01528153
+6927,0.00522391,-0.0001839515,0.0291117
+6928,0.005455784,0.000513168,0.02912022
+6929,0.004105472,0.003592906,0.02981671
+6930,-0.001208979,0.005345803,0.01764991
+6931,-0.0004458552,0.005468004,0.01671066
+6932,-0.005154305,0.00179139,0.01867512
+6933,-0.004343773,0.003334513,0.01857358
+6934,0.005440981,-0.0005400095,0.03134307
+6935,0.005374246,-0.001169264,0.03104633
+6936,-0.003277514,-0.00439556,0.001678228
+6937,-0.005484587,-0.0003741372,0.001172318
+6938,-0.005497105,-0.0001706461,0.0006284142
+6939,-0.005467012,-0.0006004088,0.0005439035
+6940,-0.003663838,-0.004100759,0.001582752
+6941,-0.005353915,-0.001247934,0.002289731
+6942,-0.003124536,0.004524074,0.03587915
+6943,-0.0007550637,-0.00539162,0.01754681
+6944,-0.0006895453,-0.005391502,0.01895813
+6945,0.004533688,-0.003113589,0.0005199753
+6946,0.002123299,0.005030192,0.01825342
+6947,0.00500947,-0.002246324,0.02807373
+6948,0.005037078,-0.002192687,0.02863525
+6949,0.005240946,-0.001618341,0.02832668
+6950,0.001989355,0.005066704,0.01694849
+6951,-0.005494651,-0.0000618284,0.003146226
+6952,-0.00545122,-0.0004026587,0.002492776
+6953,-0.005497623,0.0001613849,0.002496753
+6954,0.001688148,0.005231571,0.001365602
+6955,0.001904282,0.005141732,0.0008708736
+6956,0.0006284866,0.005463408,0.0005429984
+6957,-0.005073828,-0.002120503,0.02340308
+6958,-0.005285735,-0.001047033,0.02437635
+6959,-0.0009379159,0.005416794,0.0005397653
+6960,-0.0006522651,0.005444159,0.001131098
+6961,-0.005078351,-0.002093302,0.0004544932
+6962,0.005678663,-0.0006671031,0.04110021
+6963,0.005718812,-0.0001779419,0.04134157
+6964,0.00566142,-0.0007619422,0.04163869
+6965,0.004343399,0.00334922,0.02276328
+6966,0.003674921,0.004063057,0.02272383
+6967,0.003389452,0.004331085,0.02343732
+6968,-0.000864126,0.005431631,0.02103083
+6969,-0.005193142,-0.001571364,0.0366657
+6970,-0.004861344,-0.002560618,0.03628591
+6971,0.003841815,-0.00393559,0.01753451
+6972,-0.003875846,-0.003883403,0.01886949
+6973,-0.004275716,-0.003449418,0.01991531
+6974,-0.003321456,-0.004243018,0.01978064
+6975,0.001222839,-0.005261032,0.03011125
+6976,0.002121235,-0.00507046,0.029674
+6977,0.005332762,-0.00134034,0.04871639
+6978,0.005222342,-0.001714331,0.04860284
+6979,0.0055,-1.347111E-018,0.005058963
+6980,0.005244211,0.001588419,0.0175387
+6981,0.005241973,0.001594122,0.01697072
+6982,0.005374549,-0.001167988,0.02155942
+6983,0.005369515,-0.001190823,0.0221499
+6984,0.005395057,0.001060402,0.01669372
+6985,0.00540889,-0.0009913694,0.04053367
+6986,0.005459852,-0.0004891611,0.04027039
+6987,0.004266308,0.003467689,0.0483755
+6988,0.004390643,0.003294011,0.0489399
+6989,0.004118335,-0.003620914,0.01844184
+6990,0.004612353,-0.002955966,0.01819085
+6991,0.004272408,-0.003459037,0.0178894
+6992,-0.005330255,0.001016183,0.02753447
+6993,-0.005471081,-0.0002475464,0.02756715
+6994,-0.00547174,-0.0004622141,0.02629392
+6995,0.005453041,0.0005287231,0.01640325
+6996,-0.005425686,-0.0008839176,0.04890455
+6997,0.00457191,-0.00303184,0.01876114
+6998,-0.005482725,0.0004294792,0.04844916
+6999,-0.005479156,-0.0003861124,0.04893468
+7000,-0.005488454,0.0001608986,0.04894601
+7001,-0.004997975,0.002244721,0.0411699
+7002,-0.005098595,0.00183731,0.04220675
+7003,-0.005443179,0.0007850003,0.04217129
+7004,-0.005342559,0.001192412,0.04113444
+7005,0.002042424,-0.005103459,0.04792462
+7006,0.001535901,-0.005272343,0.04790832
+7007,0.005236533,0.001642599,0.03977555
+7008,0.005384738,-0.001118044,0.01729302
+7009,0.005444012,-0.0005768812,0.01702214
+7010,0.005444012,-0.0005768812,0.01754448
+7011,0.005416901,0.0009516391,0.04056241
+7012,0.005262271,0.001519953,0.04029669
+7013,0.004907761,-0.002481944,0.01425834
+7014,0.0017528,-0.005212724,0.04946064
+7015,0.005391163,0.001074285,0.04004127
+7016,-0.002045307,-0.00497973,0.03536143
+7017,-0.002001183,-0.004975605,0.03459525
+7018,-0.003106895,-0.004536344,0.03501495
+7019,-0.002460965,-0.004831203,0.04430378
+7020,-0.001869415,-0.005163418,0.04357422
+7021,0.005375813,-0.001162168,0.01614597
+7022,0.003303359,-0.004368894,0.04794837
+7023,0.002916617,-0.004662622,0.04799669
+7024,0.005169278,-0.0006731331,0.04165834
+7025,0.005218812,-0.0001779419,0.04194904
+7026,0.005218812,-0.0001779419,0.04134157
+7027,-0.004678216,0.002890068,0.0004848064
+7028,-0.004815194,0.002654086,0.001186023
+7029,-0.004503461,0.003134098,0.001224474
+7030,0.001009373,-0.005398885,0.04697861
+7031,0.0005534749,-0.005470462,0.04631928
+7032,0.001063328,-0.005391378,0.04775516
+7033,0.0006074299,-0.005462956,0.04709583
+7034,0.005392109,-0.001080422,0.007213475
+7035,0.005449879,-0.0005460913,0.007507099
+7036,0.005449879,-0.0005460913,0.006953786
+7037,0.005458097,0.0004996631,0.04077852
+7038,0.005413686,0.000970314,0.04113488
+7039,0.005454882,0.0005183379,0.04135098
+7040,0.005431018,-0.0006396358,0.01525936
+7041,0.005432168,-0.0006343427,0.01585796
+7042,0.005374663,-0.001167461,0.01554737
+7043,0.005268928,-0.001464221,0.00405794
+7044,0.005082473,-0.002101923,0.004327036
+7045,-0.0007012369,0.005455006,0.02584207
+7046,-0.004598158,-0.003017376,0.03394448
+7047,-0.003973942,-0.003706398,0.03460606
+7048,-0.003259744,-0.004429783,0.03380785
+7049,-0.003894687,-0.003757713,0.03311888
+7050,0.004951285,-0.002354035,0.04814315
+7051,0.004819678,-0.002648238,0.04862754
+7052,0.00312832,-0.00451843,0.04953736
+7053,0.002699153,-0.004785904,0.04950603
+7054,0.002898913,-0.004645994,0.04900394
+7055,0.001916416,0.00513143,0.006406448
+7056,0.005191474,-0.001611827,0.04243672
+7057,0.005173206,-0.001712908,0.04190138
+7058,0.005145808,-0.001838288,0.01718593
+7059,0.005372894,-0.001175506,0.01671344
+7060,0.00156884,-0.005167521,0.04049094
+7061,-0.003879805,-0.003894536,0.002352851
+7062,-0.003439518,-0.004276659,0.002196351
+7063,-0.003446391,-0.004270243,0.002937107
+7064,-0.005482438,0.0004337704,0.04945254
+7065,-0.005455092,0.0006828925,0.04895159
+7066,0.005188188,-0.001752361,0.04268467
+7067,0.005459852,-0.0004891611,0.04079609
+7068,0.0055,-1.347111E-018,0.04103745
+7069,0.005679688,-0.0006608615,0.04217403
+7070,0.005718812,-0.0001779419,0.04194904
+7071,-0.000355035,0.005487579,0.001731515
+7072,0.005168092,-0.00180174,0.04408662
+7073,0.005186218,-0.001760956,0.04323747
+7074,0.00494564,-0.002394235,0.0429679
+7075,0.0053766,-0.001155947,0.04381309
+7076,0.005673693,0.000340396,0.0416551
+7077,0.0006314278,0.005462216,0.04548736
+7078,0.0013861,0.005319834,0.04547588
+7079,0.0055,-1.347111E-018,0.03998604
+7080,0.001658557,0.005243491,0.04947423
+7081,0.001907837,0.005145654,0.04897927
+7082,-0.0001776812,0.005495378,0.04893194
+7083,-0.003172784,0.004486454,0.04889269
+7084,0.002761647,-0.004733675,0.04589647
+7085,0.003551809,-0.004154207,0.04600465
+7086,-0.005447909,0.0005851346,0.003190017
+7087,-0.005314338,0.001391026,0.003194414
+7088,0.002618144,0.004832113,0.04852749
+7089,0.002829727,0.004690376,0.04900445
+7090,0.002371055,0.00496183,0.04901035
+7091,0.00161093,0.005195594,0.03238615
+7092,0.005248242,0.001603017,0.01137861
+7093,0.005260776,0.001544462,0.01082984
+7094,-0.005420442,0.0008451047,0.01598054
+7095,-0.005458373,-0.0002622414,0.01468308
+7096,0.005029151,0.002215602,0.006702252
+7097,0.005031302,0.002210174,0.007268443
+7098,0.00287722,0.004687046,0.04804529
+7099,0.003088803,0.004545309,0.04852225
+7100,0.002597215,0.0048445,0.04950531
+7101,0.004636454,-0.002942903,0.002260533
+7102,0.004956126,-0.002343473,0.001831509
+7103,0.004761622,-0.002752089,0.001576303
+7104,-0.004284865,-0.00344479,0.04948295
+7105,-0.004116166,-0.003645422,0.049011
+7106,0.0055,-1.347111E-018,0.003926259
+7107,0.005021984,-0.002240541,0.04955958
+7108,0.002210566,-0.005023901,0.04858054
+7109,0.002668002,-0.004805212,0.04847444
+7110,0.004705732,0.002810646,0.04275855
+7111,0.004795495,0.002675669,0.0421923
+7112,0.002448299,0.004909965,0.04791715
+7113,0.00220121,0.005039682,0.04840001
+7114,0.004866452,-0.002555939,0.0383921
+7115,0.004373926,-0.003277728,0.03788398
+7116,0.004882616,-0.002522165,0.03764678
+7117,-0.005430506,0.0007556421,0.04784819
+7118,0.005485148,-0.000298148,0.04848627
+7119,0.0055,-1.347111E-018,0.04609149
+7120,0.0055,-1.347111E-018,0.0466315
+7121,0.005465243,-0.0004553364,0.04633155
+7122,0.002448765,-0.004924304,0.04904331
+7123,-0.0002528323,-0.005486328,0.01354641
+7124,0.0007116307,-0.005398974,0.01390404
+7125,0.0008854955,-0.00534099,0.01313287
+7126,-0.005465851,0.0002779944,0.004212097
+7127,-0.00132734,0.005222665,0.01306324
+7128,-0.0007811688,0.005428646,0.01431341
+7129,-0.001761242,0.005162298,0.01419606
+7130,0.00545778,0.0005015362,0.009181628
+7131,-0.005419109,0.0009249574,0.004255888
+7132,0.005128491,-0.001896979,0.03866272
+7133,0.005144655,-0.001863206,0.0379174
+7134,0.003830392,0.003943262,0.02747072
+7135,0.004281079,0.003422077,0.0279296
+7136,0.003651509,0.00409504,0.02846219
+7137,0.00007218061,-0.005485332,0.04698855
+7138,0.005386366,0.001098206,0.02993628
+7139,0.00003847939,-0.005487801,0.04777384
+7140,0.0005737287,-0.005465424,0.04788111
+7141,0.001283618,-0.005320834,0.04854912
+7142,-0.005492104,0.0001274061,0.03896576
+7143,-0.005473595,-0.0001484331,0.0378481
+7144,-0.005448004,-0.0007423875,0.03890384
+7145,0.005393732,-0.001071581,0.006666917
+7146,0.005451502,-0.0005372499,0.006407228
+7147,0.005035442,0.002200811,0.03639482
+7148,0.003575591,-0.004177461,0.03529635
+7149,0.002744106,-0.004672191,0.03480325
+7150,0.003356307,-0.004227237,0.04094372
+7151,0.002485288,-0.004903998,0.04100674
+7152,0.003163899,-0.004436009,0.04030146
+7153,0.003053226,-0.004492802,0.03928495
+7154,0.005249671,-0.00157713,0.04596765
+7155,0.003886478,0.003869592,0.0004825105
+7156,0.003502806,0.004236979,0.0004707247
+7157,0.001383821,0.005320291,0.0008804674
+7158,0.001625114,0.005253427,0.0004170435
+7159,0.002276653,-0.004991202,0.001728846
+7160,0.001204377,-0.005366514,0.0005484162
+7161,-0.003731622,0.004039864,0.0004298954
+7162,-0.003291468,0.004405577,0.0005001033
+7163,-0.003473353,0.00425388,0.0009299987
+7164,0.004231825,0.003512851,0.0004825105
+7165,0.004051351,0.00371396,0.001072153
+7166,0.004402175,0.00328342,0.001042102
+7167,-0.004917578,0.002461236,0.001687552
+7168,-0.005031752,0.002178079,0.001195073
+7169,0.004742382,0.002783684,0.002738131
+7170,0.004482212,0.003171154,0.002205859
+7171,0.004387123,0.003314409,0.002855189
+7172,-0.0008359825,-0.005430389,0.00169368
+7173,-0.0008523465,-0.005427125,0.002411713
+7174,-0.003053195,-0.004571461,0.002291827
+7175,-0.004537702,0.003098171,0.002711112
+7176,-0.001224125,0.005284253,0.04132109
+7177,-0.005122475,0.001963658,0.002358577
+7178,-0.005275811,0.001544424,0.001665732
+7179,-0.00511069,0.00200079,0.001538956
+7180,0.001773616,-0.005205917,0.0006491944
+7181,-0.002208198,-0.005006812,0.004690162
+7182,-0.002140396,-0.005044753,0.003877053
+7183,-0.003827278,0.003834042,0.02455169
+7184,-0.003476689,0.004246518,0.0233174
+7185,0.005119797,-0.001890545,0.03132322
+7186,0.0055,-1.347111E-018,0.04825269
+7187,0.005238313,0.00006028908,0.0002899747
+7188,-0.0006231687,0.005448975,0.04632488
+7189,0.004067323,-0.00370131,0.0009014077
+7190,0.00409952,-0.003666363,0.001558522
+7191,0.0001673845,0.005478455,0.04721807
+7192,0.005214691,0.001747645,0.002531779
+7193,0.005003671,0.002269932,0.002633592
+7194,0.005314851,0.001361788,0.002925748
+7195,-0.004592734,-0.003019907,0.04949576
+7196,-0.002112614,0.005047454,0.04421793
+7197,0.005440818,-0.00059295,0.04405074
+7198,0.0055,-1.347111E-018,0.04380011
+7199,0.005043771,0.002182812,0.01736487
+7200,0.005041534,0.002188514,0.01679689
+7201,-0.005252142,-0.001600445,0.04712183
+7202,0.005230477,0.001647933,0.01641167
+7203,-0.004042511,-0.003708061,0.001624008
+7204,-0.005062223,-0.002137177,0.04946598
+7205,0.0006852935,-0.005456105,0.0006501356
+7206,-0.004518317,0.003135884,0.01129319
+7207,0.001988908,-0.00510964,0.01342551
+7208,0.001841757,-0.005174648,0.01481302
+7209,0.0055,-1.347111E-018,0.009982196
+7210,0.005465042,-0.0004566486,0.0102652
+7211,0.004743525,0.002709468,0.00973281
+7212,0.005228966,0.001647532,0.00636997
+7213,0.005032779,0.00220823,0.006054525
+7214,0.005226292,0.001659256,0.02305238
+7215,0.0004420705,-0.005469507,0.001212664
+7216,0.0009731895,-0.005409006,0.001198552
+7217,0.005135955,-0.001865044,0.03922216
+7218,0.005372011,-0.001179095,0.03885415
+7219,0.004726538,0.002780738,0.04343398
+7220,0.004263099,0.003443439,0.04396314
+7221,0.005414485,-0.0009565497,0.046085
+7222,-0.0003148584,-0.005481676,0.0005625281
+7223,-0.00008495457,-0.005498259,0.001176779
+7224,0.0001814693,-0.005495371,0.0005625281
+7225,0.002402338,0.004940332,0.04391178
+7226,0.0007358813,-0.005450315,0.00184503
+7227,0.001713541,0.005222776,0.01102269
+7228,0.0004440037,0.005401032,0.01162813
+7229,-0.003606191,-0.004152658,0.04652986
+7230,0.005197602,-0.001703602,0.02247117
+7231,0.004932547,-0.002429643,0.02196775
+7232,0.00492385,-0.002446254,0.02273711
+7233,-0.0005787904,0.005464052,0.01212969
+7234,0.00525933,0.001523116,0.02857705
+7235,0.005240458,0.00161741,0.02909057
+7236,0.005083317,0.002095464,0.02861672
+7237,0.005454264,0.0005218467,0.03743837
+7238,0.005453631,0.0005254168,0.008637766
+7239,0.005220159,-0.001692702,0.03666254
+7240,0.0009972284,0.005396655,0.0168966
+7241,-0.004593182,-0.003019272,0.04842415
+7242,-0.004706935,-0.0028088,0.04785348
+7243,0.005455731,0.00051347,0.03799775
+7244,0.005390483,0.001080907,0.03772395
+7245,-0.005427397,-0.0008903308,0.03267324
+7246,0.005386345,0.00109838,0.03832862
+7247,-0.004453931,0.003221267,0.04854373
+7248,0.005202635,-0.001680767,0.02188069
+7249,0.0006742924,0.005385094,0.03733472
+7250,0.00572391,-0.0001839515,0.0291117
+7251,0.0055,-1.347111E-018,0.028842
+7252,0.003071863,0.00454274,0.02781853
+7253,0.00133222,0.005335809,0.03421024
+7254,0.005231197,0.001641743,0.00750902
+7255,0.005394813,0.001064521,0.007806625
+7256,0.005238236,0.001608818,0.008055919
+7257,-0.00310986,0.0045352,0.02724935
+7258,-0.003749075,0.003930952,0.02850948
+7259,0.0055,-1.347111E-018,0.01553211
+7260,0.0055,-1.347111E-018,0.01611672
+7261,0.005383436,-0.001120973,0.04439881
+7262,0.005230261,0.001652238,0.04421645
+7263,0.00475078,0.002746862,0.01707663
+7264,0.00466087,0.002875141,0.0165273
+7265,0.005025788,0.002218836,0.008458586
+7266,0.005039945,0.002194091,0.04307581
+7267,-0.004266541,-0.003469825,0.04731308
+7268,0.005453631,0.0005254168,0.00805092
+7269,0.0055,-1.347111E-018,0.02108043
+7270,0.005413111,0.000973315,0.02055067
+7271,0.0055,-1.347111E-018,0.01386993
+7272,0.001282404,-0.005318405,0.001786119
+7273,0.0055,-1.347111E-018,0.02058211
+7274,0.00546156,-0.0004787084,0.0207655
+7275,-0.004904133,-0.002434533,0.004241533
+7276,-0.001598769,-0.005242081,0.01011691
+7277,-0.002098303,-0.004967455,0.009053242
+7278,-0.002207375,-0.005036083,0.01147261
+7279,-0.002706909,-0.004761457,0.01040894
+7280,0.005455235,0.000516318,0.02031828
+7281,0.005455738,0.0005134296,0.03247386
+7282,0.005389461,0.001085264,0.03218443
+7283,0.00545467,0.0005195408,0.03192904
+7284,-0.002361016,0.004922457,0.0182396
+7285,-0.001790492,0.005036534,0.01912281
+7286,-0.002899715,0.004673474,0.01932877
+7287,-0.004663134,-0.002808367,0.01728144
+7288,-0.004759769,-0.00252072,0.01621797
+7289,0.005402996,0.001024245,0.03275676
+7290,0.004808271,0.00266019,0.002115206
+7291,0.005455738,0.0005134296,0.03299845
+7292,0.005408839,0.0009934644,0.01055426
+7293,0.00261894,0.004828198,0.0004538302
+7294,-0.004829393,0.002595677,0.0480617
+7295,-0.005055474,0.002166131,0.04798069
+7296,-0.004968572,0.002347588,0.047304
+7297,0.005397949,0.001046977,0.02882122
+7298,0.005397278,0.001050855,0.02936693
+7299,0.004554064,0.003083868,0.02722927
+7300,0.003704528,-0.004044542,0.04902199
+7301,-0.004842791,-0.002597169,0.04947931
+7302,-0.004016128,-0.003685932,0.02937202
+7303,0.001344043,-0.005298657,0.04621168
+7304,0.005467077,0.0004043872,0.04583218
+7305,0.00542356,0.0009135117,0.04557609
+7306,0.005427969,0.0008872104,0.04614125
+7307,0.0055,-1.347111E-018,0.04555149
+7308,0.005456483,0.0005091246,0.0452954
+7309,-0.002295407,-0.004865667,0.008115285
+7310,-0.001744712,-0.005184889,0.007091003
+7311,-0.005284982,0.001574698,0.01605826
+7312,-0.005284353,0.001289066,0.01461695
+7313,-0.002560346,-0.004863536,0.04626986
+7314,0.003915199,-0.003862799,0.02340222
+7315,0.004433175,-0.003155507,0.02292677
+7316,0.005399705,0.001038903,0.04504739
+7317,-0.003923737,-0.003830447,0.04853084
+7318,0.004200789,0.003502757,0.01498476
+7319,0.004700298,0.002836062,0.01534559
+7320,0.004633399,0.002930128,0.01590491
+7321,0.00413389,0.003596823,0.01554408
+7322,0.005456483,0.0005091246,0.04469525
+7323,0.003751825,0.003986508,0.02108412
+7324,0.003722395,0.004009382,0.02209177
+7325,0.0055,-1.347111E-018,0.01774601
+7326,0.005471657,-0.0004114048,0.01804462
+7327,0.005215131,0.001694225,0.02418889
+7328,0.005222451,0.001675988,0.02364371
+7329,0.005002111,0.002272954,0.02395315
+7330,0.0055,-1.347111E-018,0.01828276
+7331,0.005471657,-0.0004114048,0.01858137
+7332,0.005380398,-0.001137259,0.0178556
+7333,0.005236668,-0.001620789,0.03555892
+7334,-0.00395104,-0.003803045,0.04669335
+7335,-0.005219061,0.001664979,0.04796437
+7336,-0.004429609,-0.003230945,0.04897871
+7337,0.003737739,-0.004033496,0.04792515
+7338,0.005460876,-0.0004829195,0.04247739
+7339,0.005411343,-0.0009781106,0.0421867
+7340,0.005393075,-0.001079191,0.04165136
+7341,-0.00355351,0.004197921,0.002078143
+7342,0.005412339,-0.0009775537,0.003825844
+7343,-0.003201904,-0.004471647,0.0004697157
+7344,0.00470559,-0.002842835,0.04807464
+7345,0.002469345,-0.004914465,0.01767405
+7346,0.002269315,-0.005005186,0.01626061
+7347,-0.004801833,0.002663709,0.002579142
+7348,-0.004653446,0.002895698,0.001819522
+7349,-0.0001978343,0.005471287,0.003049103
+7350,0.005400211,0.001040028,0.03331514
+7351,0.005233843,0.001622094,0.03302987
+7352,0.00508456,0.002092237,0.02806003
+7353,0.005260573,0.001519889,0.02802035
+7354,0.004471657,0.003196292,0.03487122
+7355,-0.005131445,0.001967164,0.0004938561
+7356,-0.004914886,0.002443171,0.0004848064
+7357,0.004138671,-0.003619068,0.04052371
+7358,0.004203293,-0.003546554,0.04143042
+7359,0.004672411,-0.002806913,0.04093659
+7360,0.00199815,-0.005061848,0.005586342
+7361,0.001116054,-0.005380503,0.00602714
+7362,-0.001415556,0.005202353,0.01016166
+7363,0.005454962,-0.0005178804,0.003601056
+7364,-0.002739185,-0.004738177,0.01250053
+7365,-0.00152159,-0.005208636,0.01245217
+7366,-0.005496409,-0.0000406647,0.001757322
+7367,-0.005450007,-0.0006047082,0.001753344
+7368,-0.004322917,0.003346159,0.00338608
+7369,-0.005392793,-0.001080583,0.001581505
+7370,-0.005427374,-0.0008500118,0.001000478
+7371,0.0003953104,-0.005479533,0.00252306
+7372,0.0001494055,-0.005458946,0.006052782
+7373,-0.005090547,0.002028295,0.003108352
+7374,-0.00548214,0.0001589121,0.001165082
+7375,0.0003404926,-0.005488773,0.01117429
+7376,0.0001200638,-0.005497483,0.01259938
+7377,-0.001148694,-0.005219791,0.01150514
+7378,-0.005490787,-0.00009569974,0.008976226
+7379,-0.005332693,-0.0008821626,0.009665533
+7380,-0.005467916,0.000507525,0.001787075
+7381,-0.005453646,0.0007071018,0.001194835
+7382,0.004555579,-0.003046611,0.01125592
+7383,0.00485609,-0.002578144,0.01076546
+7384,0.00491947,-0.00243932,0.01128854
+7385,0.003813098,0.003961059,0.02605737
+7386,0.004335546,0.003329365,0.02597252
+7387,0.004224632,0.003495976,0.02544626
+7388,-0.003575148,-0.004145202,0.02333057
+7389,0.004815053,0.002656191,0.0004695294
+7390,0.004515427,0.003138657,0.0005595919
+7391,0.005042859,-0.002180563,0.01020755
+7392,0.003644533,0.00410028,0.005623596
+7393,0.004292785,0.003405119,0.005385362
+7394,0.003046562,0.004571305,0.04949914
+7395,0.005228583,0.001662134,0.03189209
+7396,-0.000945273,-0.005391057,0.04771219
+7397,-0.0006374408,-0.005457003,0.04698086
+7398,-0.000439129,-0.005481967,0.04767463
+7399,0.005250186,0.001536335,0.03355243
+7400,0.005232122,0.001580602,0.03411129
+7401,0.003814747,0.003871922,0.0346547
+7402,0.005067957,-0.002131959,0.03405929
+7403,0.004273416,0.00345841,0.03411859
+7404,0.003244543,0.00443977,0.03423595
+7405,0.00526447,-0.001518082,0.00347737
+7406,0.00328212,0.004382759,0.04793975
+7407,0.002896716,0.004675258,0.04738534
+7408,-0.001621762,-0.00520266,0.0335317
+7409,-0.001923231,-0.005132024,0.03205641
+7410,-0.0006719503,-0.005420514,0.03240306
+7411,0.005027804,0.002214561,0.03224872
+7412,0.005242118,0.001601114,0.03246442
+7413,0.00485491,-0.002584526,0.02746299
+7414,0.004410538,-0.003184706,0.02716422
+7415,-0.00515777,0.001889616,0.04734224
+7416,-0.005298441,0.001458827,0.04713998
+7417,-0.005428694,0.0007813261,0.04708322
+7418,0.0001217534,-0.005495425,0.0161344
+7419,0.00009953946,-0.005496653,0.01709543
+7420,0.001115457,-0.005239994,0.0167845
+7421,0.004272528,0.003434564,0.02900753
+7422,0.005456455,0.0005092896,0.02857451
+7423,0.004592521,-0.002992444,0.02817196
+7424,0.005174816,-0.000676961,0.02938593
+7425,0.005394958,-0.001069687,0.02936016
+7426,-0.005226813,-0.001555064,0.02687275
+7427,0.003285055,-0.004355638,0.03297542
+7428,0.005455731,0.00051347,0.03856003
+7429,0.004215348,0.003500565,0.04237903
+7430,0.004305111,0.003365588,0.04181279
+7431,0.004804676,0.002662134,0.04012255
+7432,0.005054297,0.002155986,0.04040142
+7433,0.004725764,0.002783504,0.04066333
+7434,-0.001316821,0.00533508,0.04545544
+7435,-0.0006090767,0.005449581,0.04547367
+7436,-0.005330221,0.001330237,0.045333
+7437,-0.005445625,0.0007013056,0.04627107
+7438,0.004236463,-0.00340182,0.02174819
+7439,0.004441872,-0.003138896,0.0221574
+7440,-0.005119964,0.001955389,0.04450267
+7441,0.003268056,0.004366331,0.04508243
+7442,0.003220734,0.004382084,0.04427349
+7443,0.003858397,0.003918203,0.0444685
+7444,0.004336235,-0.003304054,0.02078395
+7445,0.005249976,-0.001578056,0.02546413
+7446,0.0055,-1.347111E-018,0.03715464
+7447,0.002190328,0.004951879,0.03427661
+7448,0.005405142,0.001016837,0.03552528
+7449,0.005450275,0.000543945,0.03528794
+7450,0.005453895,0.0005239296,0.03583279
+7451,0.005265223,0.00150299,0.02637504
+7452,0.005094093,0.002069558,0.02635404
+7453,0.00510624,-0.002041738,0.01073063
+7454,-0.004896751,-0.002503439,0.03878299
+7455,-0.005153559,-0.001739235,0.03984612
+7456,-0.00462984,-0.002907984,0.04012386
+7457,-0.005191197,-0.001506592,0.03784072
+7458,0.005412635,-0.0009709445,0.01221603
+7459,0.005234215,-0.001611915,0.01223342
+7460,0.005378891,-0.001146276,0.01165419
+7461,0.005220083,-0.001677729,0.01277823
+7462,-0.005199177,-0.001792456,0.0009923651
+7463,-0.005255745,-0.001592276,0.0004544932
+7464,-0.005315847,-0.001374236,0.0009944466
+7465,-0.005372415,-0.001174056,0.0004565747
+7466,-0.002230602,0.004999383,0.01709011
+7467,-0.003967528,0.003808335,0.004426197
+7468,-0.003596829,0.00411723,0.00513838
+7469,-0.004333689,0.003285568,0.02229833
+7470,-0.004684279,0.002873092,0.02353263
+7471,-0.005043373,0.002065127,0.02247267
+7472,0.003005337,-0.004463005,0.02386744
+7473,-0.001916133,0.005147421,0.001761661
+7474,-0.002382294,0.004950033,0.001621051
+7475,0.004540882,-0.002988913,0.02449232
+7476,-0.00320994,0.004399757,0.003398828
+7477,-0.003469889,0.004244821,0.004152614
+7478,-0.002748909,0.004749525,0.004908768
+7479,-0.001091772,-0.005390439,0.001056658
+7480,0.0008651284,-0.005352236,0.0213197
+7481,0.0008204427,-0.005367842,0.02222181
+7482,0.0004045668,0.005485044,0.003065803
+7483,0.0008858255,0.005404208,0.002778145
+7484,0.001466516,0.005300802,0.00254622
+7485,0.0005428848,0.005471661,0.002288531
+7486,0.00002095323,0.00548192,0.002396627
+7487,0.001123575,0.005368255,0.002056606
+7488,0.00414815,-0.003592625,0.02787319
+7489,0.003308869,-0.004342977,0.02762941
+7490,0.003857387,-0.003920406,0.0270986
+7491,-0.004887351,-0.002506808,0.002509839
+7492,0.005391089,0.001082406,0.02332917
+7493,0.005387249,0.001099138,0.0239205
+7494,0.004237695,0.003459341,0.03222863
+7495,0.0055,-1.347111E-018,0.02604657
+7496,0.004679007,0.002845224,0.02114056
+7497,-0.0009115953,-0.005338277,0.01669045
+7498,-0.005186643,-0.00177632,0.002277848
+7499,-0.00246913,0.004913468,0.04941522
+7500,0.005253058,0.001546472,0.02026502
+7501,0.004609948,0.002999695,0.01996632
+7502,0.00436996,0.003335767,0.0181038
+7503,0.004532019,0.003113059,0.01882745
+7504,0.005228757,0.001666757,0.03806605
+7505,0.001850868,0.005177093,0.0306945
+7506,-0.004599368,-0.003003263,0.04578241
+7507,0.00330254,-0.00434926,0.02834189
+7508,0.002601218,-0.004837578,0.02894554
+7509,-0.002240472,-0.005021622,0.02046797
+7510,0.005394254,0.001067654,0.007240381
+7511,0.0003448372,0.005382063,0.02165604
+7512,0.005454405,0.0005210501,0.02191717
+7513,0.005461506,-0.0004790432,0.01254276
+7514,0.0055,-1.347111E-018,0.006659429
+7515,0.005179196,0.000661512,0.04971926
+7516,0.00464824,-0.002893924,0.006054747
+7517,0.004309154,-0.003413921,0.006307259
+7518,0.005242677,0.001612395,0.005781817
+7519,0.005049669,-0.002166216,0.006041433
+7520,0.00385781,-0.003877226,0.004033929
+7521,0.00105408,-0.005380323,0.03673364
+7522,0.001533471,-0.005281891,0.03564342
+7523,0.0007961714,-0.005392185,0.02319249
+7524,0.001930918,-0.005143336,0.02379957
+7525,0.005223617,0.001656508,0.0247494
+7526,0.005390776,0.001079161,0.02445725
+7527,0.005399262,0.001041444,0.02501775
+7528,0.005240562,0.001613751,0.02529453
+7529,0.00540017,0.001036168,0.0255727
+7530,0.005008119,0.002258484,0.01562839
+7531,0.005224533,0.001662916,0.01586555
+7532,0.005014063,0.002243501,0.0161745
+7533,0.001783579,0.005191891,0.007466882
+7534,0.003070353,-0.004487731,0.01833078
+7535,0.003333675,-0.004312725,0.01602568
+7536,0.003898271,-0.003877696,0.04952408
+7537,0.001805811,0.005182419,0.005499576
+7538,-0.00482681,0.002628255,0.0454625
+7539,0.005153381,-0.001902128,0.002497065
+7540,0.005203895,-0.001775958,0.001735519
+7541,0.004905612,-0.002469643,0.002593055
+7542,0.004842151,0.002579267,0.02609129
+7543,0.004753565,0.002761483,0.02543224
+7544,0.004755369,0.002716941,0.02887532
+7545,0.004762963,0.002743305,0.0300722
+7546,0.004996888,0.002269317,0.03048978
+7547,0.005014617,0.00223616,0.02981093
+7548,-0.003418657,0.004287459,0.02181941
+7549,0.005232153,0.001652938,0.03134958
+7550,0.005468558,0.0004332016,0.003019127
+7551,0.005253304,0.001543308,0.04250235
+7552,0.00524991,0.001560968,0.009181367
+7553,-0.0006497029,-0.005458932,0.04519449
+7554,-0.0001419628,-0.005461971,0.04618994
+7555,-0.0008515842,-0.005433641,0.04618225
+7556,0.00514216,-0.00187348,0.0373551
+7557,0.004238031,0.003467919,0.0412524
+7558,0.005729138,0.0001643076,0.04911156
+7559,0.005704234,-0.0002214436,0.04927626
+7560,-0.005152458,0.001918113,0.04002873
+7561,-0.001691189,0.005208118,0.001114307
+7562,-0.001924454,0.005143884,0.0004945142
+7563,-0.00219143,0.005044445,0.001116556
+7564,0.004994145,0.002276444,0.03105511
+7565,0.004990575,0.00228564,0.03159762
+7566,0.005302889,0.001424998,0.003479383
+7567,0.005460866,0.0004829844,0.003565147
+7568,0.0055,-1.347111E-018,0.003291878
+7569,0.005021424,0.002229943,0.007885382
+7570,-0.001411116,-0.005287746,0.04555776
+7571,-0.00006782077,-0.005488261,0.04125026
+7572,0.005660106,-0.0009904376,0.03250501
+7573,0.005217228,-0.0004077961,0.03221885
+7574,0.005442878,-0.0005826415,0.03251063
+7575,0.005380533,-0.001137473,0.03275752
+7576,-0.001166165,-0.00529707,0.04148632
+7577,-0.0002979172,-0.005491001,0.04223992
+7578,0.004625825,0.00297336,0.02668554
+7579,0.004103377,0.003605053,0.02677039
+7580,0.005453742,-0.0005247908,0.0191052
+7581,0.004792843,0.002681173,0.04122372
+7582,0.005101878,-0.002050358,0.003102866
+7583,-0.001233789,-0.005357415,0.003139854
+7584,0.004807568,0.002619135,0.00868715
+7585,0.0004789623,-0.005450056,0.008949421
+7586,0.005263856,-0.001521349,0.002867154
+7587,0.002550665,-0.004870222,0.01015943
+7588,-0.005429727,0.0001222986,0.01217865
+7589,-0.005437127,-0.0008292471,0.01355656
+7590,0.005394377,0.001069656,0.01332415
+7591,0.004722665,-0.002789744,0.00448354
+7592,0.004788652,-0.002642198,0.003934199
+7593,0.005016486,-0.00224947,0.004876378
+7594,-0.005179382,0.001745224,0.004378299
+7595,0.005395216,0.001061265,0.04167518
+7596,0.004769471,-0.002687806,0.003327599
+7597,-0.002171999,-0.005047954,0.01584899
+7598,-0.0009405853,-0.005327108,0.01578393
+7599,0.0001572721,-0.005495538,0.01467778
+7600,-0.0009050665,-0.005327222,0.01432731
+7601,0.004229695,0.003429831,0.01099044
+7602,0.005121059,-0.00200475,0.003709466
+7603,-0.003758064,0.004011274,0.04532008
+7604,-0.003463316,0.004239499,0.04613006
+7605,-0.0005400879,-0.005425789,0.01014944
+7606,-0.005040396,0.002142736,0.04902504
+7607,-0.005145629,0.001927289,0.0485383
+7608,0.0004370185,-0.005482608,0.04536054
+7609,-0.001210708,-0.005351251,0.04697827
+7610,-0.001749758,-0.005212785,0.04713512
+7611,-0.00007072161,-0.00547957,0.04436508
+7612,-0.0007139842,-0.005427526,0.009196214
+7613,0.0002435483,-0.005492832,0.04841974
+7614,-0.00492885,-0.002399982,0.02479084
+7615,0.00483995,0.002572419,0.04588019
+7616,0.004911993,0.002452476,0.0465199
+7617,0.005041351,-0.002198346,0.04090472
+7618,0.0009119405,-0.00537883,0.02456
+7619,0.002159022,-0.005034709,0.02498245
+7620,0.004472912,-0.003118521,0.0158777
+7621,0.00488462,-0.002523716,0.0389898
+7622,0.0055,-1.347111E-018,0.03222446
+7623,0.0055,-1.347111E-018,0.03274905
+7624,0.005224611,0.001625505,0.03579938
+7625,0.0055,-1.347111E-018,0.009460972
+7626,-0.003502175,-0.004217875,0.02472626
+7627,0.004162048,-0.003577922,0.009048826
+7628,0.004601229,-0.002977375,0.009363231
+7629,-0.002128817,-0.005068058,0.01733018
+7630,0.004243294,0.003486067,0.01632118
+7631,0.003237079,-0.004379699,0.008903272
+7632,0.005465913,0.000411426,0.01803946
+7633,-0.004102792,0.003607557,0.03173268
+7634,0.005386732,0.001102789,0.01501044
+7635,0.005212855,0.001698614,0.01471906
+7636,0.005220959,0.001678554,0.01529115
+7637,0.004249476,0.003481909,0.02331414
+7638,0.004333205,0.003357788,0.01687051
+7639,0.001525346,0.005279318,0.02482168
+7640,-0.004845113,-0.002343484,0.01167796
+7641,0.005269866,-0.00142504,0.01080305
+7642,0.005232587,-0.001622767,0.01134876
+7643,0.005416171,-0.0009485499,0.01110848
+7644,0.003906022,0.003865664,0.04715303
+7645,0.004081698,0.003686054,0.04625472
+7646,0.004298121,0.003402968,0.04708038
+7647,-0.002547854,0.004871778,0.01608114
+7648,0.004699485,0.002837638,0.01471674
+7649,0.004088112,0.003657036,0.01441688
+7650,0.005417684,0.0009479719,0.02664927
+7651,0.005418925,0.0009407746,0.02608495
+7652,-0.00545239,-0.0006704103,0.03377136
+7653,0.005229138,0.0001643076,0.04911156
+7654,0.001212625,-0.005331788,0.0337176
+7655,0.001512909,-0.005202182,0.033024
+7656,0.002355354,-0.004943444,0.03396163
+7657,0.002655638,-0.004813839,0.03326802
+7658,0.005451129,-0.0004919013,0.01136222
+7659,0.005451129,-0.0004919013,0.01199548
+7660,0.002623034,0.004809441,0.03649482
+7661,-0.002002534,-0.005091891,0.03069689
+7662,0.003746735,0.00402302,0.04174399
+7663,-0.005450973,0.0006893043,0.01330518
+7664,0.004965759,-0.002339005,0.01300023
+7665,0.004873587,-0.002545256,0.01368719
+7666,0.002609914,-0.004841084,0.02581634
+7667,-0.0001614378,0.005452801,0.01756979
+7668,0.0006030613,0.005466559,0.04948201
+7669,0.0055,-1.347111E-018,0.03497703
+7670,0.0055,-1.347111E-018,0.03434713
+7671,-0.005378933,-0.00114211,0.04829105
+7672,-0.004975622,0.002318797,0.02816342
+7673,-0.005143035,0.001437496,0.02939409
+7674,-0.005497668,0.0001348814,0.02876514
+7675,0.004344629,0.003349518,0.006078633
+7676,0.003696377,0.00404468,0.006316867
+7677,-0.00002952631,-0.005498824,0.04893813
+7678,0.005717228,-0.0004077961,0.03221885
+7679,0.0005121586,-0.005472761,0.03289605
+7680,-0.0009350438,-0.005379647,0.03130835
+7681,0.0002733723,-0.005474536,0.03178987
+7682,0.005405771,0.001011306,0.01112431
+7683,0.0008715397,0.005326644,0.03890626
+7684,0.002094105,0.005085072,0.03883939
+7685,-0.005467247,-0.0005823712,0.007638036
+7686,-0.001227397,0.005361274,0.04890864
+7687,-0.001725588,0.005198908,0.04888159
+7688,0.004648776,-0.002892825,0.005460527
+7689,0.005390768,-0.001086518,0.007783015
+7690,0.001105924,-0.005332279,0.01170778
+7691,0.004982656,0.002309899,0.02458159
+7692,0.004642652,0.002928094,0.02490597
+7693,-0.0004427462,0.00547855,0.0005913325
+7694,0.003492812,-0.004242963,0.0004362176
+7695,0.002621561,-0.004823145,0.0004659443
+7696,0.002174276,-0.005050564,0.0004659443
+7697,0.00246356,-0.004914387,0.001058807
+7698,0.005394029,0.001070349,0.01444538
+7699,0.003736432,0.004028093,0.04358441
+7700,-0.00372373,0.003946443,0.03733327
+7701,-0.004131437,0.003615796,0.03873041
+7702,0.003011355,-0.004532426,0.03858401
+7703,0.00008644516,0.005499176,0.0005064768
+7704,0.005651353,0.0008430234,0.04924682
+7705,0.003693749,-0.004047473,0.0008595521
+7706,0.003092625,-0.004483376,0.01104733
+7707,0.004999601,0.002267142,0.02512672
+7708,0.005088187,0.002084926,0.02578578
+7709,-0.00528754,0.001495822,0.0004938561
+7710,-0.005340514,0.001220749,0.001152024
+7711,-0.005224865,0.001717633,0.001046477
+7712,0.005452537,0.0005315325,0.02358985
+7713,0.00545328,0.0005273882,0.02302926
+7714,0.0055,-1.347111E-018,0.02274037
+7715,0.00545328,0.0005273882,0.02247146
+7716,0.005446975,-0.0005121647,0.02248385
+7717,0.001287398,-0.005271211,0.01558676
+7718,0.004531623,-0.003055894,0.01251321
+7719,0.005011,-0.002254209,0.01243902
+7720,0.00484256,-0.002605123,0.01179957
+7721,0.0055,-1.347111E-018,0.03381039
+7722,0.0055,-1.347111E-018,0.03327364
+7723,0.00145015,0.005303591,0.02102933
+7724,0.00462957,-0.002894832,0.03392119
+7725,0.004428973,-0.003194953,0.03459419
+7726,-0.004183828,0.003531105,0.04112467
+7727,-0.004853223,0.002520445,0.0410497
+7728,-0.004698739,0.002847053,0.04219088
+7729,0.0055,-1.347111E-018,0.04717614
+7730,0.005403946,-0.001012331,0.02105842
+7731,-0.0007097841,0.005428983,0.03299656
+7732,0.000693796,0.005401698,0.03360885
+7733,0.0004290952,0.005458248,0.03247675
+7734,0.003709486,0.004055311,0.04267573
+7735,0.004355033,0.003322717,0.03719229
+7736,0.003769151,0.003992525,0.03729471
+7737,-0.004707546,-0.002827065,0.03134139
+7738,-0.002314806,-0.004972778,0.04154817
+7739,0.004374352,-0.003250248,0.03199494
+7740,-0.004873508,0.002546276,0.04332638
+7741,0.001034834,0.005288318,0.03828454
+7742,-0.002064333,0.005076608,0.005265801
+7743,-0.004895754,-0.002479619,0.02614904
+7744,-0.004821855,-0.002595171,0.02744785
+7745,0.00519037,0.001777571,0.03523186
+7746,0.004264078,0.003472782,0.001658554
+7747,-0.004980532,-0.002277364,0.0009728745
+7748,-0.004978402,-0.002269863,0.003194497
+7749,0.005046158,0.002187662,0.0005038179
+7750,-0.003825932,-0.003916,0.0447628
+7751,0.004673788,0.002884289,0.03880411
+7752,-0.0004326989,0.005466549,0.02857155
+7753,-0.001362305,-0.00525535,0.02106501
+7754,-0.00510885,-0.00202719,0.00156754
+7755,-0.002753253,-0.004761186,0.0006064186
+7756,0.005003732,0.002255316,0.03904572
+7757,-0.004191976,-0.003554148,0.01463246
+7758,0.005028233,0.002208682,0.03831307
+7759,-0.0002340601,-0.005486998,0.04832053
+7760,0.001118115,-0.005306996,0.03103717
+7761,0.00006515799,-0.00549337,0.03060327
+7762,0.005243134,-0.001562562,0.04137205
+7763,0.00477266,0.002719158,0.04501112
+7764,0.00430598,0.003287909,0.04485591
+7765,0.004407848,0.003260316,0.04569642
+7766,0.003941168,0.003829066,0.04554121
+7767,0.005259317,0.001518358,0.02580678
+7768,0.005400711,-0.001039632,0.01000836
+7769,0.005416275,-0.0009480281,0.01052845
+7770,0.005252649,-0.001564726,0.01045603
+7771,0.005251504,-0.001568488,0.02886364
+7772,0.005415052,-0.0009554409,0.02883871
+7773,0.002286142,0.004862577,0.02410081
+7774,0.002154602,0.005056811,0.0004538302
+7775,0.005465243,-0.0004553364,0.04579154
+7776,-0.001863459,-0.005155662,0.003260025
+7777,-0.002029973,-0.005105394,0.002456549
+7778,-0.002411433,-0.004939007,0.002994743
+7779,0.0002088562,-0.005479067,0.001809145
+7780,-0.004028681,0.003470963,0.0361541
+7781,0.00537871,0.001133251,0.01943372
+7782,0.003897535,-0.003877663,0.0153918
+7783,0.003504619,0.004209042,0.001648115
+7784,0.003667679,0.004081347,0.001060368
+7785,0.002032082,0.005110788,0.04185452
+7786,0.00291754,0.00456961,0.04131607
+7787,0.00400364,0.003695795,0.0246341
+7788,-0.005400673,0.0009821749,0.0005366674
+7789,-0.005477621,0.0004810058,0.0005366674
+7790,0.0007238925,0.005409089,0.01486506
+7791,-0.003933116,0.003753866,0.04233784
+7792,-0.005491634,0.0002241406,0.0470222
+7793,-0.005477728,-0.00003943087,0.04625491
+7794,-0.005224102,-0.001561312,0.028211
+7795,-0.0009767769,0.00540458,0.04948797
+7796,-0.0004657783,0.005477363,0.04949016
+7797,-0.0007163989,0.005434057,0.04891083
+7798,0.005396345,0.001058048,0.04447573
+7799,0.00447989,0.003140373,0.04633612
+7800,0.004803784,0.002666109,0.005082218
+7801,0.004072767,0.003667725,0.0477964
+7802,0.0055,-1.347111E-018,0.01945164
+7803,0.0055,-1.347111E-018,0.02008378
+7804,0.005453742,-0.0005247908,0.01973734
+7805,0.003371632,0.004306413,0.04592563
+7806,-0.00303809,0.004539088,0.01205719
+7807,-0.001775421,0.005127938,0.01180713
+7808,0.003250745,0.004390962,0.02682705
+7809,0.005440981,-0.0005400095,0.03192319
+7810,-0.005449154,-0.0007326562,0.04612871
+7811,-0.001260042,-0.005350196,0.04834008
+7812,-0.0007538979,-0.005441106,0.04830252
+7813,-0.001040088,-0.005400748,0.04890766
+7814,-0.005464783,-0.000621411,0.03694358
+7815,0.004520554,-0.003077378,0.01364558
+7816,0.001359869,0.005327149,0.001487943
+7817,0.005374748,-0.001165165,0.0004568661
+7818,0.003251233,0.004426809,0.0022565
+7819,0.0027096,0.004776721,0.002243911
+7820,-0.004919557,-0.002456545,0.03756283
+7821,-0.0006384546,0.00545988,0.01853312
+7822,-0.0006856905,0.005452542,0.01984322
+7823,0.004210481,0.003537885,0.04945522
+7824,0.00504649,0.002173092,0.005466373
+7825,-0.004222451,-0.003450339,0.02537268
+7826,0.004931135,-0.002434968,0.01748986
+7827,0.004438135,0.003237216,0.01755216
+7828,0.005095242,-0.002064867,0.001239543
+7829,0.005453393,0.0005267521,0.0197571
+7830,-0.005140682,-0.001386768,0.02557021
+7831,0.005155677,-0.00178857,0.01185979
+7832,-0.00511724,-0.001801674,0.03190327
+7833,-0.004751542,-0.002760913,0.03253527
+7834,-0.005061699,-0.00184957,0.03330524
+7835,-0.005146765,-0.001867774,0.01279712
+7836,-0.00410148,0.003605282,0.01213478
+7837,-0.003609533,0.004149827,0.01330357
+7838,0.004434587,0.003221568,0.0100229
+7839,0.005456063,0.0005115554,0.02523242
+7840,0.005456063,0.0005115554,0.02470895
+7841,0.0055,-1.347111E-018,0.02446289
+7842,0.0055,-1.347111E-018,0.02498636
+7843,0.001131173,0.005360144,0.01820154
+7844,0.0006541557,0.005367223,0.01916487
+7845,-0.003167275,0.004494219,0.006965758
+7846,-0.002838986,0.004685192,0.005750005
+7847,0.005407253,-0.0009906783,0.04551983
+7848,0.005410318,-0.0009843523,0.04111287
+7849,0.004237097,0.00349349,0.03664877
+7850,0.004683404,-0.002865774,0.0490755
+7851,-0.0005628493,-0.005443622,0.001057723
+7852,0.004356497,-0.003356254,0.004834571
+7853,0.003127511,0.004524163,0.03504152
+7854,0.0055,-1.347111E-018,0.03610525
+7855,0.005411269,0.0009837491,0.01998949
+7856,0.005697225,-0.0004345245,0.0002899747
+7857,0.005433673,-0.0008491569,0.0006176822
+7858,0.005213074,-0.0002940542,0.0009076568
+7859,-0.0001746722,-0.005492466,0.02173472
+7860,0.004731762,0.002780118,0.006366627
+7861,0.001594571,-0.005250467,0.04728221
+7862,0.005453122,0.0005282689,0.04412359
+7863,-0.003095885,0.004543947,0.001026439
+7864,-0.001294494,0.005316237,0.007655475
+7865,-0.0003304621,0.005465821,0.007293629
+7866,0.005164627,-0.001749864,0.0397854
+7867,-0.002923716,-0.004646382,0.002895616
+7868,0.00256796,0.004793191,0.02512681
+7869,0.00189599,0.005161308,0.02594595
+7870,0.0009208446,0.005384983,0.006850535
+7871,0.001851249,0.005130968,0.02777157
+7872,0.005424395,-0.0009054195,0.04662463
+7873,0.005459151,-0.0004500832,0.04692458
+7874,0.0055,-1.347111E-018,0.01282053
+7875,0.0055,-1.347111E-018,0.01232221
+7876,-0.002405132,0.004942926,0.0004945142
+7877,-0.002645483,0.004802307,0.00102085
+7878,0.005688055,-0.0006463829,0.02883418
+7879,0.005189147,0.001780503,0.03466686
+7880,0.002915053,0.004562037,0.03933116
+7881,-0.002940877,0.00464719,0.000526336
+7882,0.003776992,0.003949836,0.01752821
+7883,0.001670026,-0.005225623,0.0425366
+7884,-0.004182546,-0.00356604,0.01618279
+7885,-0.001784707,-0.005199813,0.0494687
+7886,0.0002411869,0.005353159,0.02040411
+7887,0.005464145,-0.0004624314,0.02856448
+7888,0.0055,-1.347111E-018,0.03164434
+7889,-0.001249108,-0.005263607,0.04263404
+7890,-0.0003570674,-0.00548621,0.04332233
+7891,0.003300029,-0.004338627,0.02646092
+7892,-0.0009773735,-0.005386021,0.04426252
+7893,0.0009229239,0.005384396,0.008202444
+7894,-0.00252397,0.004886551,0.01274068
+7895,0.005456972,0.0005062794,0.02578736
+7896,-0.001033215,-0.005258552,0.01977065
+7897,-0.005297018,0.001382053,0.0123059
+7898,-0.005021194,0.001910977,0.01128914
+7899,-0.003402634,0.004315776,0.001452967
+7900,0.005456972,0.0005062794,0.02632411
+7901,0.005451364,0.0005380039,0.01525541
+7902,-0.005300013,0.001104528,0.03158412
+7903,0.002315426,0.004974651,0.02680693
+7904,-0.003733425,0.003942008,0.03017465
+7905,0.005229941,0.001650729,0.01194331
+7906,0.004684459,0.002863383,0.02953095
+7907,0.005012407,0.002241907,0.02927236
+7908,-0.004071394,0.003344289,0.02740277
+7909,-0.005345051,0.001246422,0.04338304
+7910,0.005231756,0.001659013,0.0301985
+7911,0.005229013,0.001666141,0.03076384
+7912,0.005242438,-0.001611258,0.04540247
+7913,0.005242668,0.001611663,0.02962915
+7914,-0.00527697,-0.001541587,0.001702672
+7915,-0.002015869,0.005114172,0.04688701
+7916,-0.002259606,0.004996411,0.04757738
+7917,-0.001772149,0.005206327,0.04760974
+7918,-0.005242624,0.001661356,0.04899706
+7919,0.005455729,0.0005134858,0.03912619
+7920,0.005455729,0.0005134858,0.03970407
+7921,0.005171866,-0.001748058,0.01526307
+7922,0.005040884,-0.002175497,0.01817105
+7923,0.004278816,-0.003341565,0.0353112
+7924,-0.003207635,-0.004290429,0.01162105
+7925,0.005227245,-0.001641806,0.0004568661
+7926,0.005052527,-0.002172797,0.0005048662
+7927,-0.002546607,0.004852028,0.04688046
+7928,-0.003050467,0.004576229,0.04685914
+7929,0.002115981,0.00507636,0.03788966
+7930,0.001107362,0.005293548,0.02682448
+7931,0.005174319,-0.001774085,0.0446527
+7932,0.002877779,0.004544748,0.02603725
+7933,0.003549749,0.004176631,0.0252181
+7934,-0.003790605,-0.003785164,0.03551428
+7935,-0.003033507,-0.004587627,0.03610699
+7936,0.004857279,0.002529261,0.03459114
+7937,0.005394273,-0.001054824,0.01997198
+7938,-0.004289235,-0.003377543,0.0364482
+7939,-0.003188136,-0.004432191,0.02599469
+7940,-0.0003856257,0.005473253,0.02679787
+7941,0.0006158758,0.005438925,0.02776665
+7942,-0.003095413,0.004497291,0.01398706
+7943,0.000403002,0.005341013,0.02591934
+7944,-0.003081145,-0.004425835,0.01692318
+7945,-0.003971745,-0.003769041,0.01734753
+7946,-0.001421784,0.005305438,0.0005397653
+7947,-0.001499133,-0.005240947,0.02200815
+7948,-0.0003580877,-0.005485026,0.001812736
+7949,-0.001775849,-0.005203109,0.0006038656
+7950,-0.001312722,-0.00533346,0.0004951945
+7951,-0.001554898,-0.005260088,0.001165329
+7952,-0.001529172,-0.005263791,0.04891066
+7953,0.005432168,-0.0006343427,0.01644256
+7954,0.005219262,-0.001681304,0.01332032
+7955,-0.002047317,-0.005088366,0.02798047
+7956,0.005399164,0.00104302,0.01222538
+7957,0.004988785,-0.002312256,0.009533689
+7958,0.004254765,-0.003476078,0.005659901
+7959,-0.00485726,0.002556941,0.006073493
+7960,0.004495183,0.003165115,0.03423665
+7961,-0.003160283,-0.004501399,0.04839745
+7962,-0.001265376,0.005318527,0.02765006
+7963,0.001886372,0.005166177,0.04708402
+7964,0.005229046,0.001647171,0.006942829
+7965,-0.001207612,0.005334968,0.04770103
+7966,0.005007306,0.00226006,0.01499954
+7967,-0.0009752308,0.005408424,0.04835119
+7968,-0.001488617,0.00528818,0.04830408
+7969,0.004883878,-0.002528543,0.03157191
+7970,0.00473539,0.002772746,0.0057189
+7971,0.002861277,0.004564198,0.04228244
+7972,0.003082138,-0.004548418,0.0004362176
+7973,0.002467795,0.004898177,0.04725721
+7974,-0.001390634,-0.005295175,0.0463391
+7975,-0.002087499,-0.005081072,0.04641135
+7976,0.00500425,0.002253958,0.03961345
+7977,0.005260377,-0.001467723,0.04083357
+7978,0.004209536,-0.003537944,0.0004780732
+7979,0.004359986,-0.003335059,0.0009980485
+7980,0.003916275,-0.00385863,0.0004233345
+7981,-0.003572914,-0.00413714,0.004853171
+7982,-0.004347448,-0.00327347,0.03772513
+7983,0.003170524,-0.004429569,0.04162626
+7984,0.001401641,0.0053138,0.04894118
+7985,-0.005144882,0.001929024,0.04948446
+7986,0.003907997,-0.003868362,0.04846926
+7987,0.0002068887,-0.005495084,0.04945997
+7988,0.005452537,0.0005315325,0.02417221
+7989,0.0055,-1.347111E-018,0.01497656
+7990,0.0055,-1.347111E-018,0.014421
+7991,0.001985874,-0.005120016,0.001115139
+7992,0.001489753,-0.005287432,0.001197611
+7993,0.005086612,-0.001955522,0.02716385
+7994,0.005464145,-0.0004624314,0.02806616
+7995,0.0055,-1.347111E-018,0.038268
+7996,0.00005414683,0.005499249,0.04944178
+7997,-0.00005545126,0.005495625,0.04658534
+7998,0.0004864479,0.005471106,0.0464407
+7999,-0.00004135925,0.005496231,0.04573413
+8000,-0.002880324,-0.004656838,0.0327443
+8001,0.0055,-1.347111E-018,0.00275513
+8002,0.004653627,0.002867704,0.01294209
+8003,0.00546156,-0.0004787084,0.02026717
+8004,0.005234605,0.00163028,0.0218977
+8005,-0.001669164,0.005209429,0.04613364
+8006,0.0055,-1.347111E-018,0.02834368
+8007,0.005458097,0.0004996631,0.04025281
+8008,0.002918036,0.004586341,0.0432227
+8009,0.002162773,-0.005051655,0.01265434
+8010,0.005442878,-0.0005826415,0.03303521
+8011,0.005387995,-0.001103605,0.03330235
+8012,-0.004407498,-0.003158883,0.02400484
+8013,0.005404494,-0.001005295,0.02830175
+8014,0.004142112,0.003604092,0.01354857
+8015,0.005104522,-0.002046009,0.02914812
+8016,0.005247977,-0.001547208,0.02964464
+8017,-0.004109955,0.003364822,0.02626996
+8018,0.002374935,-0.004960765,0.0117348
+8019,-0.0004365131,0.005469745,0.0483723
+8020,0.005255557,-0.001578817,0.01786712
+8021,0.0001650578,-0.005496535,0.01850675
+8022,-0.0005493641,-0.005452931,0.04892012
+8023,0.005189864,-0.001721992,0.04060483
+8024,-0.003146534,0.004488389,0.002377876
+8025,0.00007407274,-0.005493714,0.02949947
+8026,-0.002540912,-0.004864086,0.002390953
+8027,0.001141291,0.00538023,0.04946695
+8028,0.005423048,0.0009161799,0.003292856
+8029,0.005454962,-0.0005178804,0.004235437
+8030,0.005269961,-0.001533876,0.001191543
+8031,-0.002392621,0.004885635,0.006481554
+8032,0.004527461,-0.003058784,0.04286057
+8033,0.005131204,-0.001869391,0.01456897
+8034,0.002875989,0.004606424,0.0373846
+8035,-0.003576081,0.004177967,0.04432383
+8036,0.005465042,-0.0004566486,0.01080195
+8037,0.002266152,-0.005006389,0.01853796
+8038,0.004242293,0.003473347,0.04328771
+8039,0.004620309,0.002981792,0.001589407
+8040,0.005451364,0.0005380039,0.01469986
+8041,0.0055,-1.347111E-018,0.04051174
+8042,-0.001029284,-0.005350679,0.02993345
+8043,-0.003011071,0.004600458,0.02066506
+8044,-0.001794914,0.005089482,0.02004919
+8045,-0.003052774,0.004518436,0.0150028
+8046,0.003943204,0.003790074,0.00286296
+8047,0.004508453,-0.003149124,0.001683675
+8048,-0.005376358,-0.001213572,0.04111328
+8049,0.001186055,0.005370564,0.04834238
+8050,-0.004554125,0.002882763,0.03994053
+8051,-0.005498641,-0.000121996,0.04949347
+8052,0.003328756,0.00437645,0.02440594
+8053,-0.004004168,0.003486689,0.03445505
+8054,-0.00225225,-0.004994966,0.0472031
+8055,0.0055,-1.347111E-018,0.007212742
+8056,0.004682777,0.002855826,0.03192535
+8057,-0.004255376,0.003449196,0.04515815
+8058,0.003079766,0.004546283,0.0004707247
+8059,-0.00385069,-0.003823865,0.03192499
+8060,-0.004360631,0.003283611,0.0462441
+8061,0.004406704,0.003271597,0.02104145
+8062,0.004769558,0.002721375,0.03672678
+8063,-0.00007072121,0.005484315,0.004022342
+8064,0.0055,-1.347111E-018,0.01168895
+8065,0.001465214,-0.005181718,0.01796123
+8066,-0.001296419,-0.005340135,0.04944196
+8067,0.005452741,-0.0005303957,0.004791428
+8068,0.005453072,0.0005285496,0.007484676
+8069,-0.002942777,0.004645956,0.04945466
+8070,-0.002316708,-0.004988002,0.0005171522
+8071,0.002751511,-0.004761198,0.02699173
+8072,0.004836423,-0.002618382,0.04951979
+*ELEMENT, ELSET=Eall,TYPE=C3D10
+2969, 961, 339, 960, 805, 5495, 5494, 2296, 2294, 5496, 2292,
+2970, 404, 910, 985, 984, 5498, 2363, 5497, 5499, 2360, 2364,
+2971, 353, 875, 1031, 876, 5501, 2497, 5500, 5502, 1999, 2498,
+2972, 355, 1036, 1035, 487, 5504, 2514, 5503, 4471, 5506, 5505,
+2973, 1024, 349, 1023, 868, 5508, 5507, 2478, 2476, 5509, 2474,
+2974, 581, 1212, 1177, 1279, 5511, 3134, 5510, 5512, 3416, 3415,
+2975, 511, 1113, 1116, 1181, 5514, 2944, 5513, 5515, 3014, 3013,
+2976, 990, 415, 1111, 1061, 5517, 5516, 2778, 2600, 5518, 2777,
+2977, 307, 1005, 858, 857, 5520, 2567, 5519, 5521, 2422, 1945,
+2978, 804, 959, 375, 960, 2289, 5523, 5522, 2291, 2293, 5524,
+2979, 1094, 1217, 615, 596, 3158, 5526, 5525, 5527, 5528, 5033,
+2980, 1090, 959, 375, 494, 2714, 5523, 5529, 5530, 5531, 4743,
+2981, 1117, 1016, 452, 1015, 2802, 5533, 5532, 2801, 2454, 5534,
+2982, 72, 918, 216, 217, 5536, 2109, 5535, 5537, 2108, 1453,
+2983, 1285, 645, 647, 1261, 5539, 5001, 5538, 3435, 5541, 5540,
+2984, 1106, 1223, 513, 1104, 3186, 5543, 5542, 2926, 3187, 5544,
+2985, 307, 1005, 857, 839, 5520, 2422, 5521, 5545, 2421, 2225,
+2986, 413, 832, 914, 267, 5547, 2201, 5546, 4236, 5549, 5548,
+2987, 260, 911, 202, 203, 5551, 2095, 5550, 5552, 2094, 1439,
+2988, 1208, 1207, 616, 1274, 3110, 5554, 5553, 3398, 3395, 5555,
+2989, 746, 1236, 747, 1273, 5557, 5556, 5342, 5558, 3392, 5559,
+2990, 1277, 674, 671, 1260, 5561, 5147, 5560, 3405, 5563, 5562,
+2991, 297, 931, 441, 296, 5565, 5564, 4321, 3886, 5566, 4320,
+2992, 900, 238, 239, 36, 5568, 3712, 5567, 5569, 3708, 3710,
+2993, 1237, 641, 678, 642, 5571, 5112, 5570, 5572, 4985, 5113,
+2994, 297, 931, 296, 128, 5565, 5566, 3886, 5573, 2139, 5574,
+2995, 10, 149, 9, 225, 3553, 3550, 1502, 3678, 5575, 3679,
+2996, 590, 1181, 624, 511, 5577, 5576, 5058, 4821, 5515, 4929,
+2997, 989, 266, 265, 412, 5579, 3793, 5578, 5580, 4233, 4232,
+2998, 914, 266, 64, 63, 5582, 3792, 5581, 5583, 3791, 1587,
+2999, 570, 368, 1078, 477, 4742, 5585, 5584, 4741, 4432, 5586,
+3000, 43, 348, 44, 866, 4009, 4008, 1567, 5587, 5589, 5588,
+3001, 1260, 674, 671, 629, 5563, 5147, 5562, 5590, 5146, 5091,
+3002, 517, 987, 1101, 1060, 5592, 2750, 5591, 5593, 2647, 2751,
+3003, 880, 881, 319, 58, 2014, 5595, 5594, 5596, 5597, 3939,
+3004, 1144, 576, 1145, 1234, 5599, 5598, 2886, 3239, 5600, 3240,
+3005, 339, 961, 960, 376, 5495, 2296, 5494, 4132, 5602, 5601,
+3006, 144, 781, 143, 5, 1751, 1750, 1379, 3541, 5603, 3542,
+3007, 230, 480, 954, 953, 4444, 5605, 5604, 5606, 5607, 2275,
+3008, 1227, 530, 567, 586, 5609, 4765, 5608, 5610, 4807, 4806,
+3009, 329, 425, 814, 236, 4273, 5612, 5611, 4043, 4439, 5613,
+3010, 804, 339, 232, 24, 5615, 4052, 5614, 5616, 3984, 3692,
+3011, 1209, 610, 1275, 1208, 5618, 5617, 3400, 3117, 5619, 3399,
+3012, 954, 480, 373, 1085, 5605, 4467, 5620, 2699, 5622, 5621,
+3013, 956, 1086, 955, 481, 2703, 2702, 2281, 5623, 5625, 5624,
+3014, 1097, 424, 920, 994, 5627, 5626, 2784, 2785, 5628, 2390,
+3015, 1045, 1146, 471, 1147, 2888, 5630, 5629, 2890, 2892, 5631,
+3016, 1023, 1022, 460, 1124, 2475, 5633, 5632, 2822, 2821, 5634,
+3017, 364, 1053, 327, 475, 5636, 5635, 4074, 4424, 5637, 4425,
+3018, 568, 1095, 965, 1094, 5639, 2732, 5638, 5640, 2734, 2730,
+3019, 864, 310, 1019, 863, 5642, 5641, 2462, 1963, 5643, 2461,
+3020, 563, 940, 1073, 1074, 5645, 2657, 5644, 5646, 2658, 2660,
+3021, 584, 1096, 967, 1095, 5648, 2737, 5647, 5649, 2739, 2735,
+3022, 166, 803, 232, 804, 1816, 5651, 5650, 1818, 1820, 5614,
+3023, 29, 28, 341, 172, 1521, 3988, 3987, 3595, 3592, 5652,
+3024, 1155, 535, 1064, 1157, 5654, 5653, 2995, 2996, 5655, 2994,
+3025, 1197, 530, 1227, 586, 5656, 5609, 3069, 5657, 4807, 5610,
+3026, 1179, 1102, 510, 1113, 3007, 5659, 5658, 3006, 2925, 5660,
+3027, 584, 528, 529, 1096, 4843, 4616, 5044, 5648, 5662, 5661,
+3028, 548, 1009, 448, 1071, 5664, 5663, 4674, 5665, 2636, 5666,
+3029, 147, 784, 331, 785, 1759, 5668, 5667, 1761, 1763, 5669,
+3030, 697, 723, 1316, 1323, 5320, 5671, 5670, 5672, 5673, 3476,
+3031, 216, 893, 71, 894, 2049, 5675, 5674, 2051, 2053, 5676,
+3032, 242, 388, 974, 389, 4161, 5678, 5677, 4163, 4165, 5679,
+3033, 1184, 1183, 601, 499, 3100, 5681, 5680, 5682, 5683, 4857,
+3034, 724, 695, 1308, 1311, 5360, 5685, 5684, 5686, 5687, 3524,
+3035, 206, 60, 830, 263, 5689, 5688, 1885, 5690, 3782, 5691,
+3036, 153, 13, 791, 790, 3558, 5692, 1779, 1777, 5693, 1781,
+3037, 921, 281, 999, 840, 5695, 5694, 2404, 2118, 5696, 2403,
+3038, 1023, 457, 460, 312, 5697, 4384, 5632, 5698, 4372, 4382,
+3039, 331, 224, 478, 784, 4044, 4436, 4435, 5668, 5700, 5699,
+3040, 383, 943, 944, 788, 5702, 2245, 5701, 5703, 2241, 2243,
+3041, 540, 541, 1166, 1003, 4653, 5705, 5704, 5706, 5707, 2954,
+3042, 529, 1159, 528, 423, 5709, 5708, 4616, 4614, 5710, 4612,
+3043, 528, 1159, 529, 1096, 5708, 5709, 4616, 5662, 3005, 5661,
+3044, 284, 841, 428, 283, 5712, 5711, 4282, 3847, 5713, 4281,
+3045, 923, 998, 429, 996, 2400, 5715, 5714, 2393, 2401, 5716,
+3046, 996, 533, 429, 532, 5717, 4625, 5716, 5718, 4627, 4623,
+3047, 526, 1190, 1108, 1162, 5720, 3043, 5719, 5721, 3042, 2948,
+3048, 1097, 1159, 529, 423, 2942, 5709, 5722, 5723, 5710, 4614,
+3049, 447, 853, 1009, 1070, 5725, 2431, 5724, 5726, 2632, 2651,
+3050, 1169, 1250, 642, 1167, 3293, 5728, 5727, 3020, 3294, 5729,
+3051, 1165, 1070, 547, 1009, 2952, 5731, 5730, 2951, 2651, 5732,
+3052, 804, 24, 166, 167, 5616, 3584, 1818, 1819, 3583, 1402,
+3053, 1167, 445, 546, 1069, 5734, 4667, 5733, 2957, 5736, 5735,
+3054, 1102, 982, 400, 1113, 2752, 5738, 5737, 2925, 2788, 5739,
+3055, 529, 1159, 1097, 1096, 5709, 2942, 5722, 5661, 3005, 2742,
+3056, 298, 443, 932, 299, 4326, 5741, 5740, 3892, 4327, 5742,
+3057, 945, 368, 1077, 944, 5744, 5743, 2670, 2248, 5745, 2669,
+3058, 1022, 460, 1123, 455, 5633, 5746, 2819, 5747, 4459, 5748,
+3059, 33, 178, 815, 816, 3603, 1852, 5749, 5750, 1854, 1857,
+3060, 186, 820, 903, 41, 1865, 2158, 2079, 5751, 5753, 5752,
+3061, 1112, 1236, 706, 705, 3250, 5755, 5754, 5756, 5757, 5201,
+3062, 399, 981, 253, 982, 5759, 5758, 4194, 5760, 2589, 5761,
+3063, 1274, 666, 616, 610, 5762, 5080, 5555, 5763, 5079, 4909,
+3064, 429, 923, 428, 284, 5714, 5764, 4286, 4284, 5765, 4282,
+3065, 444, 851, 933, 1008, 5767, 2186, 5766, 5768, 2629, 2429,
+3066, 476, 1081, 949, 948, 5770, 2682, 5769, 5771, 2681, 2260,
+3067, 478, 940, 331, 784, 5773, 5772, 4435, 5699, 2231, 5668,
+3068, 1307, 698, 658, 1272, 5775, 5273, 5774, 3366, 5777, 5776,
+3069, 188, 42, 43, 865, 5779, 1566, 5778, 1965, 5781, 5780,
+3070, 1131, 1030, 462, 1029, 2843, 5783, 5782, 2842, 2496, 5784,
+3071, 656, 1247, 1266, 1191, 5786, 3375, 5785, 5787, 3305, 3372,
+3072, 452, 569, 1154, 456, 4740, 5789, 5788, 4370, 4737, 5790,
+3073, 42, 347, 865, 864, 4006, 5791, 5781, 5792, 5793, 1966,
+3074, 1097, 424, 529, 379, 5627, 4615, 5722, 5794, 4617, 4727,
+3075, 1132, 1031, 463, 1030, 2846, 5796, 5795, 2845, 2499, 5797,
+3076, 636, 706, 1192, 707, 5203, 5799, 5798, 5204, 5206, 5800,
+3077, 308, 37, 859, 860, 3916, 5802, 5801, 5803, 5804, 1951,
+3078, 462, 316, 352, 1030, 4391, 4086, 4389, 5783, 5806, 5805,
+3079, 463, 316, 462, 1030, 4393, 4391, 4478, 5797, 5806, 5783,
+3080, 449, 1010, 548, 1071, 5808, 5807, 4847, 5809, 2637, 5665,
+3081, 529, 379, 485, 968, 4727, 4497, 4750, 5810, 5812, 5811,
+3082, 517, 1060, 408, 409, 5593, 5813, 4575, 4576, 5814, 4225,
+3083, 1002, 433, 1066, 926, 5816, 5815, 2619, 2412, 5817, 2618,
+3084, 889, 66, 359, 888, 5819, 4030, 5818, 2038, 5821, 5820,
+3085, 237, 179, 35, 817, 5823, 5822, 3706, 5824, 1860, 5825,
+3086, 987, 518, 1101, 1160, 5827, 5826, 2750, 2935, 5828, 2959,
+3087, 1281, 1214, 653, 1213, 3423, 5830, 5829, 3420, 3145, 5831,
+3088, 850, 298, 96, 297, 5833, 3887, 5832, 5834, 3889, 3885,
+3089, 452, 1015, 1016, 344, 5534, 2454, 5533, 4354, 5836, 5835,
+3090, 1002, 536, 432, 1064, 5838, 4634, 5837, 2614, 5840, 5839,
+3091, 1154, 1117, 452, 1015, 2913, 5532, 5788, 2912, 2801, 5534,
+3092, 897, 898, 364, 75, 2065, 5842, 5841, 5843, 5844, 4041,
+3093, 76, 898, 328, 899, 5846, 5845, 3957, 5847, 2068, 5848,
+3094, 328, 223, 1013, 454, 4042, 5850, 5849, 4434, 4363, 5851,
+3095, 1265, 1173, 746, 1236, 3369, 5853, 5852, 3371, 3251, 5557,
+3096, 782, 223, 330, 454, 5855, 3999, 5854, 5856, 4363, 4362,
+3097, 1055, 413, 414, 832, 5858, 4240, 5857, 2573, 5547, 5859,
+3098, 502, 391, 503, 1114, 4528, 4530, 4532, 5860, 5862, 5861,
+3099, 638, 1246, 1166, 1099, 5864, 3330, 5863, 5865, 3300, 2956,
+3100, 715, 1303, 682, 1332, 5867, 5866, 5285, 5868, 1737, 5869,
+3101, 801, 800, 231, 481, 1811, 5871, 5870, 5872, 5873, 4446,
+3102, 287, 431, 925, 432, 4291, 5875, 5874, 4293, 4295, 5876,
+3103, 331, 784, 8, 224, 5668, 5877, 3967, 4044, 5700, 3676,
+3104, 1166, 1246, 637, 1170, 3330, 5879, 5878, 2977, 3306, 5880,
+3105, 286, 843, 430, 924, 5882, 5881, 4288, 5883, 2207, 5884,
+3106, 987, 1060, 409, 830, 2647, 5814, 5885, 2370, 2596, 5886,
+3107, 942, 787, 943, 366, 2238, 2240, 2242, 5887, 5889, 5888,
+3108, 943, 575, 1076, 1075, 5891, 5890, 2666, 2664, 5892, 2668,
+3109, 920, 424, 425, 278, 5626, 4274, 5893, 5894, 4269, 4271,
+3110, 969, 1097, 424, 970, 2741, 5627, 5895, 2323, 2917, 5896,
+3111, 547, 447, 548, 1009, 4671, 4673, 4675, 5732, 5724, 5664,
+3112, 921, 1005, 999, 365, 2423, 2610, 2404, 5897, 5899, 5898,
+3113, 383, 575, 943, 366, 4759, 5891, 5702, 4148, 4760, 5888,
+3114, 186, 40, 185, 820, 5901, 5900, 1422, 1865, 5902, 1866,
+3115, 179, 237, 35, 34, 5823, 3706, 5822, 5903, 3705, 1558,
+3116, 383, 575, 1076, 943, 4759, 5890, 5904, 5702, 5891, 2666,
+3117, 1274, 1207, 616, 585, 3395, 5554, 5555, 5905, 5906, 5032,
+3118, 1178, 565, 649, 611, 5908, 5012, 5907, 5909, 4894, 5013,
+3119, 535, 432, 1063, 431, 4632, 5911, 5910, 4631, 4295, 5912,
+3120, 262, 830, 263, 409, 5913, 5691, 3784, 4223, 5886, 4224,
+3121, 373, 1085, 955, 954, 5621, 2700, 5914, 5620, 2699, 2278,
+3122, 968, 379, 342, 813, 5812, 4138, 5915, 2316, 5917, 5916,
+3123, 418, 1110, 991, 992, 5919, 2774, 5918, 5920, 2773, 2602,
+3124, 987, 830, 409, 410, 2370, 5886, 5885, 5921, 5922, 4228,
+3125, 184, 38, 183, 819, 5924, 5923, 1420, 1863, 5925, 1864,
+3126, 1112, 705, 706, 635, 5756, 5201, 5754, 5926, 5200, 5202,
+3127, 697, 1323, 735, 729, 5672, 5927, 5398, 5386, 5928, 5315,
+3128, 8, 784, 331, 147, 5877, 5668, 3967, 3547, 1759, 5667,
+3129, 603, 1074, 1075, 563, 5930, 2665, 5929, 4865, 5646, 5931,
+3130, 1057, 1187, 514, 1106, 3030, 5933, 5932, 2765, 3031, 5934,
+3131, 417, 1110, 418, 524, 5935, 5919, 4252, 4598, 5936, 4599,
+3132, 1255, 1273, 747, 1192, 3394, 5559, 5937, 3335, 3391, 5938,
+3133, 327, 1052, 363, 475, 5940, 5939, 4097, 4425, 5941, 4494,
+3134, 451, 578, 582, 1120, 4777, 4779, 4767, 5942, 5944, 5943,
+3135, 463, 1032, 1133, 489, 5946, 2849, 5945, 4480, 5948, 5947,
+3136, 384, 1019, 1121, 1020, 5950, 2812, 5949, 5951, 2466, 2813,
+3137, 451, 578, 1119, 380, 4777, 5953, 5952, 4352, 4778, 5954,
+3138, 1206, 574, 1189, 1161, 5956, 5955, 3104, 3101, 5957, 3038,
+3139, 1133, 1032, 1134, 489, 2849, 2851, 2853, 5947, 5948, 5958,
+3140, 16, 794, 228, 335, 5960, 5959, 3684, 3976, 5961, 4048,
+3141, 1276, 1275, 1210, 717, 3520, 3401, 3404, 5962, 5964, 5963,
+3142, 955, 799, 800, 337, 2276, 1808, 2277, 5965, 5967, 5966,
+3143, 1340, 763, 726, 745, 5969, 5406, 5968, 5970, 5408, 5338,
+3144, 782, 783, 330, 145, 1757, 5971, 5854, 1753, 1755, 5972,
+3145, 1132, 555, 463, 564, 5973, 4690, 5795, 5974, 4719, 4718,
+3146, 257, 910, 404, 827, 5975, 5498, 4208, 5976, 2165, 5977,
+3147, 736, 1326, 1360, 759, 5979, 1707, 5978, 5446, 5981, 5980,
+3148, 1098, 996, 1189, 532, 2744, 2973, 2972, 5982, 5718, 5983,
+3149, 910, 827, 257, 200, 2165, 5976, 5975, 2093, 1879, 5984,
+3150, 694, 724, 702, 1311, 5264, 5263, 5190, 5985, 5686, 5986,
+3151, 675, 1302, 1321, 1324, 5988, 3521, 5987, 5989, 3522, 1738,
+3152, 16, 156, 228, 794, 3566, 5990, 3684, 5960, 1788, 5959,
+3153, 401, 982, 826, 1059, 5992, 2357, 5991, 5993, 2591, 2590,
+3154, 1276, 717, 1210, 607, 5962, 5963, 3404, 5994, 5231, 5995,
+3155, 315, 488, 1029, 1028, 4474, 5997, 5996, 5998, 5999, 2493,
+3156, 374, 482, 958, 494, 4500, 6001, 6000, 4509, 4508, 6002,
+3157, 1334, 1312, 702, 1319, 3378, 6004, 6003, 1712, 3377, 6005,
+3158, 559, 1140, 1232, 1141, 6007, 3082, 6006, 6008, 2874, 3230,
+3159, 1264, 498, 1197, 608, 6010, 6009, 3363, 6011, 4884, 6012,
+3160, 1142, 1041, 1143, 469, 2876, 2878, 2880, 6013, 6015, 6014,
+3161, 1107, 508, 507, 622, 6017, 4548, 6016, 6018, 4819, 4923,
+3162, 990, 1055, 1111, 414, 2575, 2779, 2778, 6019, 5857, 6020,
+3163, 1141, 559, 1201, 1232, 6008, 6021, 3234, 3230, 6006, 3235,
+3164, 1163, 389, 974, 500, 6022, 5679, 2960, 6023, 4522, 6024,
+3165, 129, 931, 297, 128, 2138, 5565, 6025, 1482, 2139, 5573,
+3166, 276, 73, 74, 919, 3821, 1597, 3822, 6026, 6028, 6027,
+3167, 1143, 1041, 1042, 469, 2878, 2532, 2879, 6014, 6015, 6029,
+3168, 788, 226, 383, 332, 6030, 4146, 5703, 6031, 3970, 4147,
+3169, 1163, 389, 501, 390, 6022, 4524, 6032, 6033, 4168, 4525,
+3170, 1188, 1269, 1254, 587, 3380, 3390, 3332, 6034, 6036, 6035,
+3171, 967, 235, 966, 811, 6038, 6037, 2314, 2312, 6039, 2310,
+3172, 639, 1246, 638, 1099, 6040, 5864, 4975, 6041, 3300, 5865,
+3173, 1149, 1148, 560, 1235, 2898, 6043, 6042, 3245, 3243, 6044,
+3174, 974, 388, 500, 389, 5678, 4521, 6024, 5679, 4165, 4522,
+3175, 77, 223, 781, 328, 3958, 6046, 6045, 3956, 4042, 6047,
+3176, 638, 637, 1166, 1246, 4972, 5878, 5863, 5864, 5879, 3330,
+3177, 669, 1281, 1282, 1214, 6049, 3426, 6048, 6050, 3423, 3424,
+3178, 34, 179, 857, 35, 5903, 1941, 6051, 1558, 5822, 6052,
+3179, 595, 631, 526, 1190, 4838, 4835, 4836, 6053, 6054, 5720,
+3180, 1315, 1292, 670, 608, 3533, 6056, 6055, 6057, 6058, 5088,
+3181, 16, 794, 335, 157, 5960, 5961, 3976, 3565, 1789, 6059,
+3182, 364, 454, 1013, 1053, 4441, 5851, 6060, 5636, 6061, 2565,
+3183, 76, 328, 77, 899, 3957, 3956, 1600, 5847, 5848, 6062,
+3184, 1062, 421, 1162, 422, 6064, 6063, 2940, 6065, 4264, 6066,
+3185, 606, 687, 660, 1286, 5143, 5145, 5065, 6067, 6069, 6068,
+3186, 1252, 708, 1186, 1246, 6071, 6070, 3325, 3326, 6072, 3299,
+3187, 1222, 1114, 1188, 502, 3184, 3035, 3288, 6073, 5860, 6074,
+3188, 547, 643, 1165, 601, 4987, 6075, 5730, 4990, 4989, 6076,
+3189, 241, 387, 240, 976, 4158, 4157, 3718, 6077, 6079, 6078,
+3190, 578, 1225, 1196, 644, 6081, 3199, 6080, 4994, 6083, 6082,
+3191, 977, 390, 1163, 975, 6084, 6033, 3011, 2344, 6085, 2947,
+3192, 458, 347, 1020, 311, 4375, 6087, 6086, 4374, 4102, 6088,
+3193, 1188, 587, 1184, 1269, 6034, 6089, 3173, 3380, 6036, 3381,
+3194, 1023, 312, 460, 1022, 5698, 4382, 5632, 2475, 6090, 5633,
+3195, 505, 621, 1193, 1180, 4816, 6092, 6091, 6093, 6094, 3052,
+3196, 1163, 389, 977, 974, 6022, 6095, 3011, 2960, 5679, 2343,
+3197, 748, 1192, 747, 707, 6096, 5938, 5345, 5346, 5800, 5344,
+3198, 219, 73, 218, 919, 6098, 6097, 1455, 2110, 6028, 2111,
+3199, 946, 791, 947, 227, 2250, 2252, 2254, 6099, 6101, 6100,
+3200, 985, 828, 260, 911, 2362, 6103, 6102, 2365, 2166, 5551,
+3201, 1242, 1241, 694, 1311, 3287, 6105, 6104, 3519, 3518, 5985,
+3202, 1362, 728, 733, 764, 6107, 5302, 6106, 6108, 5410, 5412,
+3203, 406, 985, 405, 259, 6110, 6109, 4216, 4214, 6111, 4212,
+3204, 636, 1192, 637, 707, 5798, 6112, 4969, 5204, 5800, 5205,
+3205, 637, 1246, 708, 707, 5879, 6072, 5207, 5205, 6113, 5209,
+3206, 561, 471, 551, 1147, 4708, 4681, 4709, 6114, 5631, 6115,
+3207, 456, 1014, 1154, 1015, 6116, 2911, 5790, 6117, 2451, 2912,
+3208, 404, 984, 985, 405, 5499, 2364, 5497, 4213, 6118, 6109,
+3209, 329, 279, 77, 816, 3962, 3831, 3959, 6119, 6121, 6120,
+3210, 33, 816, 815, 329, 5750, 1857, 5749, 3960, 6119, 6122,
+3211, 448, 854, 935, 304, 6124, 2216, 6123, 4342, 6126, 6125,
+3212, 1141, 490, 559, 1140, 6127, 4700, 6008, 2874, 6128, 6007,
+3213, 562, 1088, 957, 1087, 6130, 2708, 6129, 6131, 2710, 2706,
+3214, 33, 329, 77, 816, 3960, 3959, 3702, 5750, 6119, 6120,
+3215, 169, 168, 26, 806, 1404, 3588, 3587, 1825, 1824, 6132,
+3216, 519, 1160, 1194, 518, 6134, 3054, 6133, 4584, 5828, 6135,
+3217, 1089, 1088, 649, 1213, 2713, 6137, 6136, 3140, 3138, 6138,
+3218, 26, 807, 169, 806, 6139, 1827, 3587, 6132, 1829, 1825,
+3219, 33, 816, 2, 178, 5750, 6140, 1526, 3603, 1854, 3605,
+3220, 628, 1185, 1244, 1194, 6142, 3291, 6141, 6143, 3056, 3292,
+3221, 39, 38, 309, 861, 1562, 3919, 3918, 6144, 6146, 6145,
+3222, 30, 235, 174, 29, 3698, 6147, 3598, 1522, 3699, 3596,
+3223, 901, 819, 241, 976, 2157, 6149, 6148, 2338, 2337, 6077,
+3224, 1223, 1106, 513, 514, 3186, 5542, 5543, 6150, 5934, 4568,
+3225, 1220, 709, 1186, 1240, 6152, 6151, 3169, 3277, 6153, 3278,
+3226, 1013, 899, 781, 328, 2442, 2152, 2443, 5849, 5848, 6047,
+3227, 243, 40, 41, 820, 3722, 1564, 3723, 6154, 5902, 5753,
+3228, 1243, 1103, 1111, 522, 3289, 2780, 3290, 6155, 6157, 6156,
+3229, 39, 861, 309, 862, 6144, 6145, 3918, 6158, 1957, 6159,
+3230, 171, 27, 28, 234, 3590, 1520, 3593, 6160, 3697, 3696,
+3231, 257, 827, 199, 200, 5976, 1880, 6161, 5984, 1879, 1436,
+3232, 77, 899, 781, 222, 6062, 2152, 6045, 6162, 2067, 2070,
+3233, 901, 819, 183, 38, 2157, 1864, 2074, 6163, 5925, 5923,
+3234, 958, 482, 803, 959, 6001, 6164, 2286, 2290, 6165, 2288,
+3235, 380, 578, 1119, 599, 4778, 5953, 5954, 4850, 4876, 6166,
+3236, 416, 415, 1111, 522, 4246, 5516, 6167, 4593, 4592, 6156,
+3237, 285, 83, 84, 114, 3848, 1533, 3849, 6168, 3620, 3621,
+3238, 503, 1114, 1222, 502, 5861, 3184, 6169, 4532, 5860, 6073,
+3239, 202, 203, 58, 260, 1439, 6171, 6170, 5550, 5552, 3774,
+3240, 1156, 504, 505, 394, 6173, 4539, 6172, 6174, 4535, 4537,
+3241, 1266, 1257, 656, 1191, 3373, 6175, 5785, 3372, 3340, 5787,
+3242, 1045, 471, 1044, 323, 5629, 6176, 2541, 6177, 4415, 6178,
+3243, 857, 180, 858, 35, 1942, 1943, 1945, 6052, 6180, 6179,
+3244, 1044, 889, 1045, 323, 2537, 2539, 2541, 6178, 6181, 6177,
+3245, 1195, 1157, 632, 1191, 3059, 6183, 6182, 3248, 3046, 6184,
+3246, 63, 64, 886, 358, 1587, 6186, 6185, 4029, 4028, 6187,
+3247, 900, 35, 817, 238, 6188, 5825, 2154, 5568, 3707, 6189,
+3248, 322, 64, 886, 887, 3945, 6186, 6190, 6191, 6192, 2032,
+3249, 1165, 601, 548, 547, 6076, 4858, 6193, 5730, 4990, 4675,
+3250, 582, 1225, 1120, 578, 6194, 3198, 5943, 4779, 6081, 5944,
+3251, 67, 68, 270, 916, 1591, 3804, 3803, 6195, 6197, 6196,
+3252, 607, 651, 1211, 662, 5046, 6199, 6198, 5071, 5070, 6200,
+3253, 242, 388, 241, 974, 4161, 4160, 3721, 5677, 5678, 6201,
+3254, 529, 1096, 485, 584, 5661, 6202, 4750, 5044, 5648, 4801,
+3255, 1306, 685, 704, 1335, 6204, 5195, 6203, 3357, 6206, 6205,
+3256, 342, 31, 175, 813, 3989, 3600, 6207, 5916, 6208, 1845,
+3257, 834, 271, 272, 69, 6210, 3811, 6209, 6211, 3807, 3809,
+3258, 975, 973, 903, 244, 2336, 2331, 2334, 6212, 6214, 6213,
+3259, 582, 1225, 1121, 1120, 6194, 3200, 6215, 5943, 3198, 2814,
+3260, 1090, 1089, 583, 1214, 2716, 6217, 6216, 3144, 3143, 6218,
+3261, 1119, 1225, 1196, 578, 3197, 3199, 3062, 5953, 6081, 6080,
+3262, 1175, 1207, 603, 1075, 3107, 6220, 6219, 2998, 3105, 5929,
+3263, 944, 226, 383, 788, 6221, 4146, 5701, 2243, 6030, 5703,
+3264, 1068, 542, 441, 1006, 6223, 4655, 6222, 2625, 6225, 6224,
+3265, 1120, 1225, 1119, 578, 3198, 3197, 2811, 5944, 6081, 5953,
+3266, 1012, 237, 238, 817, 6227, 3709, 6226, 2440, 5824, 6189,
+3267, 485, 1096, 529, 968, 6202, 5661, 4750, 5811, 2738, 5810,
+3268, 1189, 531, 1001, 1161, 6229, 6228, 3037, 3038, 6230, 2939,
+3269, 17, 335, 795, 157, 3975, 6232, 6231, 3568, 6059, 1791,
+3270, 720, 1247, 1265, 1314, 6234, 3370, 6233, 6235, 3530, 3462,
+3271, 569, 574, 1117, 1161, 4772, 6237, 6236, 6238, 5957, 3060,
+3272, 1103, 1219, 522, 1243, 3166, 6239, 6157, 3289, 3309, 6155,
+3273, 681, 1247, 746, 720, 6241, 6240, 5308, 5246, 6234, 5310,
+3274, 202, 260, 58, 57, 5550, 3774, 6170, 6242, 3773, 1581,
+3275, 4, 178, 2, 816, 1414, 3605, 3540, 1855, 1854, 6140,
+3276, 746, 1247, 1265, 720, 6240, 3370, 5852, 5310, 6234, 6233,
+3277, 1262, 1223, 627, 1245, 3352, 6244, 6243, 3354, 3318, 6245,
+3278, 734, 1270, 1252, 709, 6247, 3383, 6246, 5306, 6249, 6248,
+3279, 617, 654, 1266, 656, 5039, 6251, 6250, 5051, 5054, 5785,
+3280, 1167, 642, 545, 1172, 5729, 4983, 6252, 2969, 6254, 6253,
+3281, 680, 1223, 627, 1262, 6255, 6244, 5164, 6256, 3352, 6243,
+3282, 1165, 643, 547, 1169, 6075, 4987, 5730, 2967, 6258, 6257,
+3283, 544, 543, 1164, 641, 4663, 6260, 6259, 4980, 4979, 6261,
+3284, 681, 1173, 746, 1247, 6262, 5853, 5308, 6241, 3304, 6240,
+3285, 1359, 1368, 768, 1365, 1658, 6264, 6263, 1657, 1638, 6265,
+3286, 1364, 1368, 775, 1358, 1622, 6267, 6266, 1655, 1656, 6268,
+3287, 746, 1173, 1265, 1247, 5853, 3369, 5852, 6240, 3304, 3370,
+3288, 671, 1258, 1277, 1260, 6269, 3499, 5560, 5562, 3387, 3405,
+3289, 213, 916, 834, 68, 2104, 2203, 1894, 6270, 6197, 6271,
+3290, 1308, 673, 680, 701, 6273, 5165, 6272, 6274, 5188, 5187,
+3291, 457, 1125, 1024, 1023, 6276, 2825, 6275, 5697, 2824, 2478,
+3292, 680, 673, 1308, 1262, 5165, 6273, 6272, 6256, 6277, 3508,
+3293, 23, 803, 165, 338, 6278, 1815, 3582, 3981, 6280, 6279,
+3294, 590, 1181, 511, 1116, 5577, 5515, 4821, 6281, 3013, 5513,
+3295, 756, 1357, 1354, 1369, 6283, 1654, 6282, 6284, 1653, 1651,
+3296, 371, 795, 479, 335, 6286, 6285, 4466, 4121, 6232, 4443,
+3297, 1240, 710, 678, 709, 6288, 5298, 6287, 6153, 5297, 5234,
+3298, 1259, 696, 686, 630, 6290, 5280, 6289, 6291, 5173, 5140,
+3299, 519, 518, 1194, 628, 4584, 6135, 6133, 4940, 4939, 6143,
+3300, 1277, 1258, 671, 1309, 3499, 6269, 5560, 2968, 3511, 6292,
+3301, 532, 1189, 1001, 996, 5983, 3037, 6293, 5718, 2973, 2411,
+3302, 965, 1095, 568, 378, 2732, 5639, 5638, 6294, 6295, 4878,
+3303, 1255, 1273, 1318, 761, 3394, 3171, 3538, 6296, 6298, 6297,
+3304, 1368, 1359, 768, 775, 1658, 6263, 6264, 6267, 6299, 5489,
+3305, 1169, 1167, 642, 546, 3020, 5729, 5727, 6300, 5733, 4984,
+3306, 1122, 1021, 458, 1020, 2816, 6302, 6301, 2815, 2469, 6086,
+3307, 636, 1170, 637, 1192, 6303, 5880, 4969, 5798, 3048, 6112,
+3308, 1054, 635, 1112, 1171, 6304, 5926, 2782, 2979, 6305, 2988,
+3309, 527, 1190, 526, 1162, 6306, 5720, 4610, 6307, 3042, 5721,
+3310, 650, 597, 560, 1293, 5018, 4845, 5015, 6308, 6310, 6309,
+3311, 538, 635, 1054, 1171, 4962, 6304, 6311, 6312, 6305, 2979,
+3312, 95, 128, 296, 94, 3646, 5574, 3882, 1544, 3645, 3881,
+3313, 505, 504, 1156, 1239, 4539, 6173, 6172, 6313, 6314, 3302,
+3314, 1012, 238, 900, 817, 6226, 5568, 2446, 2440, 6189, 2154,
+3315, 627, 673, 1262, 1224, 5095, 6277, 6243, 6315, 6316, 3501,
+3316, 484, 809, 341, 234, 6318, 6317, 4453, 4454, 6319, 4054,
+3317, 1294, 765, 734, 761, 6321, 5414, 6320, 6322, 5417, 5401,
+3318, 171, 808, 27, 234, 1831, 6323, 3590, 6160, 6324, 3697,
+3319, 58, 355, 880, 57, 4022, 6325, 5596, 1581, 4023, 6326,
+3320, 260, 828, 259, 57, 6103, 6327, 3775, 3773, 6328, 3771,
+3321, 56, 828, 910, 201, 6330, 2197, 6329, 6331, 1882, 2092,
+3322, 837, 920, 424, 994, 2175, 5626, 6332, 2388, 2390, 5628,
+3323, 833, 915, 66, 211, 2202, 6334, 6333, 1892, 2102, 6335,
+3324, 1082, 1083, 549, 496, 2692, 6337, 6336, 6338, 6339, 4725,
+3325, 1309, 696, 1259, 1258, 6340, 6290, 3510, 3511, 6341, 3345,
+3326, 666, 610, 1275, 717, 5079, 5617, 6342, 5243, 5232, 5964,
+3327, 1309, 1259, 686, 1316, 3510, 6289, 6343, 3477, 3537, 6344,
+3328, 594, 1258, 1243, 1219, 6346, 3343, 6345, 6347, 3342, 3309,
+3329, 259, 910, 56, 828, 6348, 6329, 3770, 6327, 2197, 6330,
+3330, 1212, 676, 1178, 1280, 6350, 6349, 3136, 3417, 6351, 3418,
+3331, 280, 1005, 307, 839, 6352, 5520, 4000, 6353, 2421, 5545,
+3332, 1002, 1064, 1155, 536, 2614, 2995, 2919, 5838, 5840, 6354,
+3333, 1280, 697, 653, 1281, 6356, 5174, 6355, 3445, 6357, 5829,
+3334, 1263, 585, 1274, 666, 6358, 5905, 1744, 6359, 5099, 5762,
+3335, 1281, 1280, 1178, 653, 3445, 3418, 3419, 5829, 6355, 6360,
+3336, 1109, 520, 1185, 1182, 6362, 6361, 3025, 3018, 6363, 3172,
+3337, 505, 1180, 1193, 1239, 6093, 3052, 6091, 6313, 3276, 3275,
+3338, 770, 767, 1354, 1360, 5454, 6365, 6364, 6366, 6367, 1650,
+3339, 1178, 1280, 676, 653, 3418, 6351, 6349, 6360, 6355, 5105,
+3340, 678, 641, 1220, 640, 5112, 6369, 6368, 5214, 4981, 6370,
+3341, 1306, 704, 1288, 1320, 6203, 6371, 3231, 3232, 6372, 3233,
+3342, 910, 259, 56, 258, 6348, 3770, 6329, 6373, 3772, 3768,
+3343, 1373, 205, 830, 912, 6375, 1886, 6374, 6376, 2096, 2199,
+3344, 637, 1192, 1170, 1246, 6112, 3048, 5880, 5879, 3307, 3306,
+3345, 1086, 565, 562, 1087, 6378, 4723, 6377, 2707, 6379, 6131,
+3346, 1085, 565, 1178, 611, 6380, 5908, 3135, 6381, 4894, 5909,
+3347, 676, 1212, 1178, 611, 6350, 3136, 6349, 5106, 6382, 5909,
+3348, 1081, 496, 949, 1082, 6384, 6383, 2682, 2686, 6338, 2684,
+3349, 793, 948, 334, 476, 2256, 6386, 6385, 6387, 5771, 4427,
+3350, 1210, 1209, 1079, 598, 3120, 3116, 3118, 6388, 6390, 6389,
+3351, 1309, 1316, 686, 723, 3477, 6344, 6343, 6391, 5671, 5257,
+3352, 232, 804, 375, 339, 5614, 5522, 4130, 4052, 5615, 4129,
+3353, 1306, 667, 704, 685, 6392, 5194, 6203, 6204, 5137, 5195,
+3354, 1197, 530, 586, 608, 5656, 4807, 5657, 6012, 4883, 4885,
+3355, 727, 752, 1265, 720, 5363, 6394, 6393, 5276, 5361, 6233,
+3356, 1057, 1106, 514, 406, 2765, 5934, 5932, 6395, 6396, 4567,
+3357, 45, 867, 44, 312, 6398, 6397, 1568, 3924, 6399, 3925,
+3358, 510, 1113, 1181, 1179, 5660, 3014, 6400, 5658, 3006, 3164,
+3359, 594, 1259, 1219, 630, 6401, 3344, 6347, 4947, 6291, 6402,
+3360, 1123, 498, 460, 1124, 6403, 4516, 5746, 2823, 6404, 5634,
+3361, 1358, 775, 780, 1359, 6268, 5491, 6405, 1659, 6299, 6406,
+3362, 257, 256, 199, 827, 3766, 6407, 6161, 5976, 6408, 1880,
+3363, 736, 767, 770, 1360, 5425, 5454, 5464, 5978, 6367, 6366,
+3364, 624, 510, 511, 1181, 4928, 4557, 4929, 5576, 6400, 5515,
+3365, 793, 156, 228, 15, 1786, 5990, 6409, 6410, 3563, 3685,
+3366, 550, 487, 1138, 466, 4783, 6412, 6411, 4680, 4473, 6413,
+3367, 771, 751, 753, 1366, 5440, 5367, 5441, 6414, 6416, 6415,
+3368, 474, 1052, 363, 1051, 6417, 5939, 4422, 6418, 2562, 6419,
+3369, 537, 435, 1065, 434, 4639, 6421, 6420, 4638, 4304, 6422,
+3370, 859, 37, 182, 860, 5802, 6423, 1947, 1951, 5804, 1949,
+3371, 107, 179, 839, 1375, 1904, 2071, 1906, 6424, 6426, 6425,
+3372, 307, 839, 34, 280, 5545, 6427, 3915, 4000, 6353, 3963,
+3373, 140, 937, 306, 855, 2151, 6429, 6428, 1937, 2190, 6430,
+3374, 34, 839, 307, 857, 6427, 5545, 3915, 6051, 2225, 5521,
+3375, 1145, 486, 470, 576, 6432, 4470, 6431, 5598, 4769, 4768,
+3376, 449, 1010, 450, 548, 5808, 6433, 4349, 4847, 5807, 4745,
+3377, 1351, 1365, 757, 1350, 1648, 6435, 6434, 1649, 1642, 6436,
+3378, 369, 1081, 476, 948, 6437, 5770, 4428, 6438, 2681, 5771,
+3379, 1351, 773, 1327, 739, 6440, 6439, 1729, 6441, 5445, 6442,
+3380, 1351, 1350, 757, 739, 1649, 6436, 6434, 6441, 6443, 5387,
+3381, 1291, 762, 759, 1326, 6445, 5413, 6444, 2689, 6446, 5981,
+3382, 1349, 1368, 1362, 764, 1621, 1625, 1624, 6447, 6448, 6108,
+3383, 53, 255, 197, 198, 3759, 6450, 6449, 6451, 6452, 1434,
+3384, 290, 435, 1066, 927, 4302, 6454, 6453, 6455, 6456, 2620,
+3385, 590, 512, 1174, 1116, 4822, 6458, 6457, 6281, 6459, 2993,
+3386, 46, 823, 248, 905, 6461, 6460, 3738, 6462, 2192, 6463,
+3387, 33, 816, 77, 2, 5750, 6120, 3702, 1526, 6140, 1601,
+3388, 760, 1358, 1319, 742, 6465, 1711, 6464, 5396, 6467, 6466,
+3389, 308, 344, 37, 860, 3997, 3996, 3916, 5803, 6468, 5804,
+3390, 175, 31, 176, 813, 3600, 3599, 1411, 1845, 6208, 1846,
+3391, 1200, 1268, 614, 1296, 3471, 6470, 6469, 3473, 3472, 6471,
+3392, 603, 1074, 1175, 1075, 5930, 2997, 6219, 5929, 2665, 2998,
+3393, 769, 1372, 1352, 772, 6473, 1614, 6472, 5438, 6475, 6474,
+3394, 984, 1104, 403, 983, 2757, 6477, 6476, 2593, 2758, 6478,
+3395, 764, 1368, 775, 774, 6448, 6267, 5483, 5450, 6479, 5481,
+3396, 737, 1352, 1364, 772, 6481, 1615, 6480, 5439, 6474, 6482,
+3397, 889, 888, 359, 1044, 2038, 5820, 5818, 2537, 2536, 6483,
+3398, 742, 774, 1364, 772, 5473, 6485, 6484, 5465, 5451, 6482,
+3399, 576, 1202, 1145, 1234, 6486, 3086, 5598, 5600, 3262, 3240,
+3400, 1302, 668, 648, 1267, 6488, 5083, 6487, 3487, 6490, 6489,
+3401, 1365, 1338, 777, 1359, 1666, 6492, 6491, 1657, 1667, 6493,
+3402, 527, 596, 595, 1218, 4839, 4841, 4837, 6494, 6496, 6495,
+3403, 1330, 729, 1309, 732, 6498, 6497, 1748, 6499, 5304, 6500,
+3404, 1098, 534, 613, 632, 6502, 4951, 6501, 6503, 4952, 4954,
+3405, 1375, 839, 78, 34, 6425, 6505, 6504, 6506, 6427, 3833,
+3406, 1325, 1280, 676, 1279, 3421, 6351, 6507, 3429, 3428, 6508,
+3407, 980, 508, 397, 1107, 6510, 4546, 6509, 2766, 6017, 6511,
+3408, 736, 1355, 1360, 1326, 6512, 1644, 5978, 5979, 1706, 1707,
+3409, 1101, 591, 518, 517, 6513, 4938, 5826, 5591, 4826, 4581,
+3410, 543, 542, 1068, 1168, 4659, 6223, 6514, 6515, 6516, 2962,
+3411, 639, 640, 1186, 1168, 4978, 6518, 6517, 6519, 6520, 3028,
+3412, 1358, 1359, 780, 1334, 1659, 6406, 6405, 1674, 1675, 6521,
+3413, 452, 456, 1154, 1015, 4370, 5790, 5788, 5534, 6117, 2912,
+3414, 412, 411, 1109, 519, 4234, 6523, 6522, 4583, 4582, 6524,
+3415, 738, 1371, 779, 767, 6526, 6525, 5477, 5426, 6527, 5476,
+3416, 344, 1015, 1016, 860, 5836, 2454, 5835, 6468, 2450, 2452,
+3417, 1066, 435, 1065, 927, 6454, 6421, 2650, 2620, 6456, 2616,
+3418, 243, 244, 975, 820, 3727, 6212, 6528, 6154, 6529, 2335,
+3419, 38, 860, 344, 861, 6530, 6468, 3998, 6146, 1954, 6531,
+3420, 648, 1201, 605, 556, 6533, 6532, 5009, 5006, 6534, 4871,
+3421, 489, 464, 1134, 552, 4482, 6535, 5958, 4684, 4683, 6536,
+3422, 779, 1367, 771, 1366, 6538, 6537, 5490, 6539, 1611, 6414,
+3423, 1310, 1339, 1342, 699, 3150, 1665, 3151, 6540, 6542, 6541,
+3424, 397, 979, 396, 906, 6544, 6543, 4189, 6545, 2347, 6546,
+3425, 1189, 644, 613, 574, 6548, 4993, 6547, 5955, 4992, 4897,
+3426, 668, 1324, 721, 1313, 6550, 6549, 5282, 6551, 3201, 6552,
+3427, 1331, 721, 1353, 1324, 6554, 6553, 1689, 1719, 6549, 1697,
+3428, 757, 1337, 1350, 1347, 6555, 1700, 6436, 6556, 1701, 1669,
+3429, 403, 257, 404, 827, 4206, 4208, 4210, 6557, 5976, 5977,
+3430, 859, 1015, 308, 860, 2449, 6558, 5801, 1951, 2450, 5803,
+3431, 1199, 1285, 647, 1230, 3468, 5538, 6559, 3076, 3434, 6560,
+3432, 1090, 1214, 583, 1215, 3144, 6218, 6216, 3146, 3148, 6561,
+3433, 1335, 730, 1320, 1328, 6563, 6562, 1616, 1617, 6564, 1618,
+3434, 1178, 611, 649, 653, 5909, 5013, 5907, 6360, 5036, 5035,
+3435, 351, 461, 1028, 1027, 4385, 6566, 6565, 6567, 6568, 2490,
+3436, 631, 686, 1284, 664, 5141, 6570, 6569, 5075, 5150, 6571,
+3437, 548, 495, 1158, 450, 4746, 6573, 6572, 4745, 4510, 6574,
+3438, 307, 345, 858, 1005, 4104, 6575, 5519, 5520, 6576, 2567,
+3439, 427, 922, 1001, 972, 6578, 2409, 6577, 6579, 2328, 2410,
+3440, 1012, 817, 856, 237, 2440, 2153, 2437, 6227, 5824, 6580,
+3441, 1331, 698, 1313, 1317, 6582, 6581, 3202, 3282, 6583, 3411,
+3442, 193, 48, 194, 871, 6585, 6584, 1430, 1982, 6586, 1983,
+3443, 1222, 504, 1156, 1056, 6587, 6173, 3190, 3183, 6588, 2922,
+3444, 871, 1027, 351, 872, 2485, 6567, 6589, 1987, 2486, 6590,
+3445, 229, 797, 18, 159, 6592, 6591, 3686, 6593, 1797, 3571,
+3446, 1297, 689, 726, 741, 6595, 5272, 6594, 6596, 5327, 5326,
+3447, 474, 1050, 1152, 1051, 6598, 2905, 6597, 6418, 2559, 2906,
+3448, 1110, 523, 417, 1103, 6599, 4596, 5935, 2775, 6601, 6600,
+3449, 4, 2, 143, 1374, 3540, 3539, 1378, 6602, 6604, 6603,
+3450, 32, 33, 815, 329, 1525, 5749, 6605, 3961, 3960, 6122,
+3451, 1297, 741, 726, 754, 6596, 5326, 6594, 6606, 5371, 5370,
+3452, 628, 591, 518, 1194, 4941, 4938, 4939, 6143, 6607, 6135,
+3453, 472, 1049, 473, 325, 6609, 6608, 4488, 4418, 6610, 4420,
+3454, 1329, 763, 1340, 1338, 6611, 5969, 1680, 1676, 6612, 1681,
+3455, 1353, 1348, 750, 738, 1660, 6614, 6613, 6615, 6616, 5355,
+3456, 936, 1010, 449, 854, 2432, 5808, 6617, 2189, 2433, 6618,
+3457, 461, 1128, 1129, 1027, 6620, 2838, 6619, 6568, 2834, 2836,
+3458, 351, 314, 871, 49, 4061, 6621, 6589, 4015, 3928, 6622,
+3459, 195, 351, 873, 872, 6624, 6623, 1988, 1986, 6590, 1990,
+3460, 351, 195, 873, 50, 6624, 1988, 6623, 4014, 6626, 6625,
+3461, 617, 1225, 646, 1257, 6628, 6627, 5024, 6629, 3355, 6630,
+3462, 668, 1302, 675, 1324, 6488, 5988, 5104, 6550, 3522, 5989,
+3463, 1233, 557, 605, 1201, 6632, 4870, 6631, 3238, 6633, 6532,
+3464, 1098, 632, 1195, 1157, 6503, 6182, 3057, 2924, 6183, 3059,
+3465, 668, 675, 725, 1324, 5104, 5269, 5268, 6550, 5989, 6634,
+3466, 108, 839, 921, 280, 1905, 2116, 2115, 6635, 6353, 6636,
+3467, 1013, 223, 782, 454, 5850, 5855, 2444, 5851, 4363, 5856,
+3468, 593, 521, 1243, 629, 4829, 6638, 6637, 5030, 4944, 6639,
+3469, 891, 324, 1046, 360, 6641, 6640, 2543, 6642, 4094, 6643,
+3470, 405, 1106, 514, 513, 6644, 5934, 4566, 4565, 5542, 4568,
+3471, 958, 802, 374, 957, 2285, 6645, 6000, 2287, 2283, 6646,
+3472, 403, 256, 257, 827, 4205, 3766, 4206, 6557, 6408, 5976,
+3473, 909, 256, 403, 827, 6648, 4205, 6647, 2196, 6408, 6557,
+3474, 206, 883, 205, 60, 2019, 2018, 1442, 5689, 6650, 6649,
+3475, 357, 884, 61, 883, 6652, 6651, 4027, 6653, 2023, 6654,
+3476, 42, 41, 903, 244, 1565, 5752, 6655, 3726, 3725, 6213,
+3477, 45, 905, 247, 822, 6657, 6656, 3735, 6658, 2160, 6659,
+3478, 730, 1335, 1320, 704, 6563, 1616, 6562, 5340, 6205, 6372,
+3479, 501, 609, 1184, 587, 4917, 6661, 6660, 4808, 4918, 6089,
+3480, 1123, 455, 1122, 1021, 5748, 6662, 2820, 2818, 6663, 2816,
+3481, 704, 1335, 703, 730, 6205, 6664, 5196, 5340, 6563, 5391,
+3482, 1166, 541, 638, 1099, 5705, 4971, 5863, 2956, 6665, 5865,
+3483, 736, 1355, 738, 1371, 6512, 6666, 5323, 6667, 1608, 6526,
+3484, 274, 72, 836, 918, 3816, 6669, 6668, 6670, 5536, 2205,
+3485, 210, 267, 209, 832, 6672, 6671, 1446, 1889, 5549, 1890,
+3486, 320, 357, 61, 883, 4067, 4027, 3940, 6673, 6653, 6654,
+3487, 320, 883, 61, 60, 6673, 6654, 3940, 3941, 6650, 1584,
+3488, 1307, 1272, 658, 1234, 3366, 5776, 5774, 3507, 3388, 6674,
+3489, 747, 1273, 1255, 761, 5559, 3394, 5937, 5424, 6298, 6296,
+3490, 472, 1049, 325, 1048, 6609, 6610, 4418, 6675, 2553, 6676,
+3491, 606, 1228, 492, 619, 6678, 6677, 4874, 4916, 6679, 4914,
+3492, 460, 498, 1123, 455, 4516, 6403, 5746, 4459, 4517, 5748,
+3493, 61, 883, 206, 60, 6654, 2019, 6680, 1584, 6650, 5689,
+3494, 326, 72, 894, 895, 3953, 6682, 6681, 6683, 6684, 2056,
+3495, 586, 1271, 1227, 1292, 6685, 3385, 5610, 6686, 3482, 3456,
+3496, 1159, 422, 994, 1062, 6688, 6687, 2932, 2933, 6065, 2649,
+3497, 423, 994, 1097, 1159, 6689, 2785, 5723, 5710, 2932, 2942,
+3498, 326, 894, 362, 1050, 6681, 6690, 4096, 6691, 2554, 6692,
+3499, 1228, 579, 488, 1130, 6694, 4785, 6693, 3217, 6696, 6695,
+3500, 665, 586, 1271, 652, 5078, 6685, 6697, 5077, 5028, 6698,
+3501, 1317, 685, 703, 698, 6700, 5191, 6699, 6583, 5176, 5192,
+3502, 1241, 1223, 680, 1262, 3280, 6255, 6701, 3353, 3352, 6256,
+3503, 1227, 586, 567, 652, 5610, 4806, 5608, 6702, 5028, 5027,
+3504, 566, 619, 1198, 652, 4915, 6704, 6703, 5026, 5029, 6705,
+3505, 517, 1105, 408, 1060, 6707, 6706, 4575, 5593, 2759, 5813,
+3506, 1227, 566, 1198, 652, 6708, 6703, 3215, 6702, 5026, 6705,
+3507, 217, 894, 72, 895, 2052, 6682, 5537, 2054, 2056, 6684,
+3508, 1377, 265, 264, 913, 6710, 3790, 6709, 6711, 6713, 6712,
+3509, 546, 545, 1167, 642, 4669, 6252, 5733, 4984, 4983, 5729,
+3510, 1308, 673, 1310, 1262, 6273, 6714, 3224, 3508, 6277, 3515,
+3511, 72, 326, 894, 362, 3953, 6681, 6682, 4036, 4096, 6690,
+3512, 1364, 774, 775, 1368, 6485, 5481, 6266, 1622, 6479, 6267,
+3513, 72, 217, 216, 894, 5537, 1453, 5535, 6682, 2052, 2051,
+3514, 1043, 470, 1145, 486, 6715, 6431, 2884, 6716, 4470, 6432,
+3515, 549, 1212, 581, 577, 6717, 5511, 4797, 4774, 6718, 4796,
+3516, 253, 252, 825, 981, 3754, 6720, 6719, 5758, 6721, 2354,
+3517, 1219, 1259, 594, 1258, 3344, 6401, 6347, 3342, 3345, 6346,
+3518, 175, 812, 342, 813, 1843, 6722, 6207, 1845, 1847, 5916,
+3519, 661, 645, 1298, 1261, 5068, 6724, 6723, 6725, 5541, 3470,
+3520, 559, 1141, 1201, 556, 6008, 3234, 6021, 4703, 6726, 6534,
+3521, 560, 491, 561, 1148, 4705, 4707, 4710, 6043, 6728, 6727,
+3522, 362, 894, 72, 71, 6690, 6682, 4036, 4037, 5676, 1595,
+3523, 498, 530, 460, 1124, 4776, 4619, 4516, 6404, 6729, 5634,
+3524, 1219, 1259, 1221, 630, 3344, 3358, 3181, 6402, 6291, 6730,
+3525, 1373, 205, 882, 60, 6375, 2016, 6731, 6732, 6649, 6733,
+3526, 1325, 718, 716, 719, 6735, 5237, 6734, 6736, 5241, 5240,
+3527, 72, 894, 216, 71, 6682, 2051, 5535, 1595, 5676, 5674,
+3528, 1066, 927, 845, 290, 2620, 2180, 2617, 6453, 6455, 6737,
+3529, 1125, 457, 1024, 370, 6276, 6275, 2825, 6738, 4373, 6739,
+3530, 372, 336, 229, 952, 4123, 4049, 4124, 6740, 6742, 6741,
+3531, 667, 1293, 1288, 597, 6744, 3526, 6743, 5081, 6310, 6745,
+3532, 1263, 1274, 1288, 666, 1744, 1746, 1745, 6359, 5762, 6746,
+3533, 1199, 1130, 1131, 579, 3194, 2844, 3072, 6747, 6696, 6748,
+3534, 615, 664, 595, 1217, 5117, 5076, 5138, 5526, 6750, 6749,
+3535, 823, 46, 248, 249, 6461, 3738, 6460, 6751, 3740, 3742,
+3536, 441, 542, 1068, 543, 4655, 6223, 6222, 4657, 4659, 6514,
+3537, 367, 1115, 939, 938, 6753, 2794, 6752, 6754, 2793, 2230,
+3538, 823, 1058, 248, 905, 2585, 6755, 6460, 2192, 2586, 6463,
+3539, 367, 454, 1115, 938, 4364, 6756, 6753, 6754, 6757, 2793,
+3540, 146, 145, 7, 783, 1381, 3546, 3545, 1756, 1755, 6758,
+3541, 25, 24, 339, 167, 1517, 3984, 3983, 3586, 3583, 6759,
+3542, 260, 829, 911, 203, 6760, 2198, 5551, 5552, 1884, 2094,
+3543, 825, 981, 252, 907, 2354, 6721, 6720, 2194, 2351, 6761,
+3544, 1171, 1170, 636, 1192, 2987, 6303, 6762, 3049, 3048, 5798,
+3545, 3, 179, 107, 1375, 1415, 1904, 1460, 6763, 6426, 6424,
+3546, 55, 910, 56, 258, 6764, 6329, 1579, 3767, 6373, 3768,
+3547, 1058, 506, 1156, 1180, 6766, 6765, 3010, 3012, 6767, 3016,
+3548, 257, 200, 199, 54, 5984, 1436, 6161, 3764, 6769, 6768,
+3549, 1233, 1201, 605, 1307, 3238, 6532, 6631, 3505, 3504, 6770,
+3550, 257, 54, 199, 256, 3764, 6768, 6161, 3766, 3762, 6407,
+3551, 430, 285, 286, 924, 4287, 3853, 4288, 5884, 6771, 5883,
+3552, 45, 46, 868, 349, 1569, 6773, 6772, 4011, 4010, 5509,
+3553, 579, 1228, 488, 606, 6694, 6693, 4785, 4875, 6678, 4873,
+3554, 614, 675, 668, 1302, 5102, 5104, 5084, 6774, 5988, 6488,
+3555, 822, 190, 45, 905, 1869, 6775, 6658, 2160, 2083, 6657,
+3556, 808, 377, 340, 234, 6777, 4134, 6776, 6324, 4133, 4081,
+3557, 20, 337, 162, 799, 3980, 6778, 3574, 6779, 5967, 1804,
+3558, 905, 45, 247, 248, 6657, 3735, 6656, 6463, 3737, 3739,
+3559, 1243, 522, 594, 1219, 6155, 4831, 6345, 3309, 6239, 6347,
+3560, 870, 47, 350, 313, 6781, 4013, 6780, 6782, 3926, 4060,
+3561, 214, 213, 834, 68, 1450, 1894, 1893, 6783, 6270, 6271,
+3562, 748, 709, 1252, 708, 5368, 6248, 6784, 5347, 5213, 6071,
+3563, 20, 19, 230, 161, 1512, 3689, 3688, 3575, 3572, 6785,
+3564, 682, 1341, 1298, 659, 6787, 3090, 6786, 5127, 6789, 6788,
+3565, 369, 792, 227, 947, 6791, 6790, 4118, 6792, 2253, 6100,
+3566, 271, 69, 834, 68, 3807, 6211, 6210, 3806, 1592, 6271,
+3567, 144, 6, 782, 223, 3544, 6793, 1752, 6794, 3674, 5855,
+3568, 65, 267, 210, 915, 3795, 6672, 6795, 6796, 6797, 2103,
+3569, 633, 1191, 632, 1157, 6798, 6184, 4957, 6799, 3046, 6183,
+3570, 833, 212, 67, 916, 1891, 6801, 6800, 2171, 2105, 6195,
+3571, 548, 601, 1165, 1183, 4858, 6076, 6193, 6802, 5681, 3034,
+3572, 560, 1203, 1149, 1235, 6803, 3246, 6042, 6044, 3247, 3245,
+3573, 916, 269, 67, 833, 6804, 3801, 6195, 2171, 6805, 6800,
+3574, 15, 334, 155, 14, 3973, 6806, 3564, 1507, 3974, 3561,
+3575, 925, 431, 1063, 432, 5875, 5912, 2609, 5876, 4295, 5911,
+3576, 829, 986, 260, 911, 2366, 6807, 6760, 2198, 2367, 5551,
+3577, 617, 498, 582, 1226, 4911, 4855, 5023, 6808, 6810, 6809,
+3578, 734, 710, 745, 1270, 5307, 5376, 5390, 6247, 6812, 6811,
+3579, 758, 1300, 755, 743, 6814, 6813, 5388, 5389, 6815, 5377,
+3580, 335, 795, 157, 794, 6232, 1791, 6059, 5961, 1793, 1789,
+3581, 1101, 516, 517, 1105, 6816, 4577, 5591, 2762, 6817, 6707,
+3582, 1288, 666, 704, 667, 6746, 5197, 6371, 6743, 5101, 5194,
+3583, 425, 970, 920, 971, 6818, 2916, 5893, 6819, 2327, 2571,
+3584, 971, 278, 838, 920, 6821, 6820, 2326, 2571, 5894, 2395,
+3585, 793, 334, 155, 15, 6385, 6806, 1785, 6410, 3973, 3564,
+3586, 1111, 522, 415, 521, 6156, 4592, 5516, 6822, 4594, 4590,
+3587, 547, 1070, 1165, 1169, 5731, 2952, 5730, 6257, 2965, 2967,
+3588, 76, 838, 279, 278, 6824, 6823, 3830, 3828, 6820, 3832,
+3589, 561, 1235, 1202, 1290, 6826, 3244, 6825, 6827, 3503, 3453,
+3590, 699, 753, 1342, 740, 5365, 6828, 6541, 5185, 5366, 6829,
+3591, 833, 990, 268, 915, 2379, 6831, 6830, 2202, 2377, 6832,
+3592, 845, 927, 120, 290, 2180, 2130, 1917, 6737, 6455, 6833,
+3593, 240, 818, 901, 997, 6835, 2114, 6834, 6836, 2397, 2396,
+3594, 1000, 1004, 847, 437, 2419, 2418, 2406, 6837, 6839, 6838,
+3595, 694, 1311, 1241, 695, 5985, 3518, 6105, 5266, 5687, 6840,
+3596, 583, 612, 571, 1215, 5003, 4896, 4799, 6561, 6842, 6841,
+3597, 1184, 501, 1163, 500, 6660, 6032, 3023, 6843, 4526, 6023,
+3598, 1337, 1344, 739, 1350, 1731, 6845, 6844, 1700, 1702, 6443,
+3599, 623, 1181, 624, 1238, 6846, 5576, 4930, 6847, 3272, 6848,
+3600, 672, 620, 1254, 587, 5094, 6850, 6849, 5093, 4812, 6035,
+3601, 894, 362, 325, 71, 6690, 4072, 6851, 5676, 4037, 3950,
+3602, 1269, 1256, 679, 1250, 3444, 6853, 6852, 3414, 3338, 6854,
+3603, 1250, 1269, 1249, 663, 3414, 3413, 3348, 6855, 6857, 6856,
+3604, 617, 1225, 582, 646, 6628, 6194, 5023, 5024, 6627, 4997,
+3605, 120, 927, 121, 290, 2130, 2129, 1474, 6833, 6455, 6858,
+3606, 221, 838, 76, 278, 1902, 6824, 6859, 6860, 6820, 3828,
+3607, 243, 389, 977, 390, 4164, 6095, 6861, 4166, 4168, 6084,
+3608, 683, 1238, 693, 624, 6863, 6862, 5265, 5129, 6848, 5167,
+3609, 400, 399, 253, 982, 4198, 4194, 4196, 5738, 5760, 5761,
+3610, 660, 1199, 606, 1286, 6865, 6864, 5065, 6068, 3483, 6067,
+3611, 559, 1296, 1200, 614, 6867, 3473, 6866, 4899, 6471, 6469,
+3612, 472, 325, 361, 1048, 4418, 4095, 4416, 6675, 6676, 6868,
+3613, 278, 971, 838, 279, 6821, 2326, 6820, 3832, 6869, 6823,
+3614, 1232, 1296, 1200, 559, 3488, 3473, 3083, 6006, 6867, 6866,
+3615, 782, 454, 330, 938, 5856, 4362, 5854, 2226, 6757, 6870,
+3616, 546, 446, 547, 1070, 4668, 4670, 4672, 6871, 6872, 5731,
+3617, 52, 874, 316, 875, 6874, 6873, 3933, 6875, 1996, 6876,
+3618, 330, 783, 782, 938, 5971, 1757, 5854, 6870, 2227, 2226,
+3619, 23, 232, 166, 803, 3693, 5650, 3581, 6278, 5651, 1816,
+3620, 254, 908, 826, 982, 6878, 2195, 6877, 6879, 2355, 2357,
+3621, 469, 468, 1142, 1041, 4409, 6880, 6013, 6015, 6881, 2876,
+3622, 367, 783, 330, 938, 6882, 5971, 4114, 6754, 2227, 6870,
+3623, 469, 557, 1142, 468, 4694, 6883, 6013, 4409, 4695, 6880,
+3624, 609, 663, 1249, 1269, 5073, 6856, 6884, 6885, 6857, 3413,
+3625, 703, 685, 1317, 1335, 5191, 6700, 6699, 6664, 6206, 3283,
+3626, 1142, 469, 1143, 557, 6013, 6014, 2880, 6883, 4694, 6886,
+3627, 133, 933, 99, 132, 2142, 6887, 3655, 1486, 2143, 3654,
+3628, 243, 389, 242, 977, 4164, 4163, 3724, 6861, 6095, 6888,
+3629, 1155, 535, 536, 1064, 5654, 4636, 6354, 2995, 5653, 5840,
+3630, 371, 949, 496, 950, 6889, 6383, 4513, 6890, 2263, 6891,
+3631, 988, 411, 1109, 412, 6892, 6523, 2771, 6893, 4234, 6522,
+3632, 371, 949, 228, 476, 6889, 6894, 4122, 4429, 5769, 4426,
+3633, 559, 490, 1141, 556, 4700, 6127, 6008, 4703, 4693, 6726,
+3634, 932, 443, 851, 299, 5741, 6895, 2213, 5742, 4327, 6896,
+3635, 264, 988, 265, 411, 6898, 6897, 3790, 4229, 6892, 4230,
+3636, 228, 156, 793, 794, 5990, 1786, 6409, 5959, 1788, 1790,
+3637, 1176, 598, 1210, 1080, 6899, 6388, 3301, 2999, 6900, 3119,
+3638, 747, 752, 1273, 761, 5403, 6901, 5559, 5424, 5423, 6298,
+3639, 920, 838, 221, 278, 2395, 1902, 2112, 5894, 6820, 6860,
+3640, 580, 1081, 496, 476, 6902, 6384, 4792, 4790, 5770, 4771,
+3641, 613, 533, 1098, 532, 4950, 6903, 6501, 4949, 4627, 5982,
+3642, 658, 618, 1272, 698, 5061, 6904, 5776, 5273, 5177, 5777,
+3643, 1320, 717, 1328, 730, 6906, 6905, 1618, 6562, 5288, 6564,
+3644, 440, 296, 441, 849, 4318, 4320, 4322, 6907, 6909, 6908,
+3645, 296, 127, 128, 849, 6910, 1481, 5574, 6909, 1926, 1925,
+3646, 701, 744, 1339, 751, 5335, 6912, 6911, 5357, 5399, 6913,
+3647, 420, 1108, 992, 993, 6915, 2769, 6914, 6916, 2768, 2598,
+3648, 1086, 1087, 562, 956, 2707, 6131, 6377, 2703, 2705, 6917,
+3649, 396, 506, 1058, 979, 4541, 6766, 6918, 6543, 6919, 2588,
+3650, 736, 1346, 1326, 762, 6920, 1717, 5979, 5418, 6921, 6446,
+3651, 528, 1218, 527, 1159, 6922, 6494, 4613, 5708, 3185, 6923,
+3652, 731, 711, 1304, 665, 5293, 6925, 6924, 5292, 5215, 6926,
+3653, 1373, 60, 882, 59, 6732, 6733, 6731, 6927, 1583, 6928,
+3654, 1200, 559, 1139, 1232, 6866, 6929, 3080, 3083, 6006, 3081,
+3655, 731, 665, 1304, 1287, 5292, 6926, 6924, 6930, 6931, 3267,
+3656, 764, 757, 1365, 1362, 5411, 6435, 6932, 6108, 6933, 1637,
+3657, 297, 95, 129, 128, 3884, 3647, 6025, 5573, 3646, 1482,
+3658, 129, 850, 297, 931, 1928, 5834, 6025, 2138, 2212, 5565,
+3659, 297, 95, 96, 129, 3884, 1545, 3885, 6025, 3647, 3648,
+3660, 166, 165, 23, 803, 1401, 3582, 3581, 1816, 1815, 6278,
+3661, 830, 264, 206, 263, 6935, 6934, 1885, 5691, 3787, 5690,
+3662, 932, 443, 298, 850, 5741, 4326, 5740, 2185, 6936, 5833,
+3663, 1099, 1003, 1166, 541, 2747, 2954, 2956, 6665, 5707, 5705,
+3664, 929, 92, 294, 125, 6938, 3875, 6937, 2134, 3640, 6939,
+3665, 1090, 960, 375, 959, 2715, 5524, 5529, 2714, 2293, 5523,
+3666, 128, 931, 296, 849, 2139, 5566, 5574, 1925, 2184, 6909,
+3667, 668, 1267, 1302, 1313, 6490, 3487, 6488, 6551, 1733, 3523,
+3668, 298, 850, 443, 442, 5833, 6936, 4326, 4324, 6940, 4328,
+3669, 548, 450, 1158, 1010, 4745, 6574, 6572, 5807, 6433, 2930,
+3670, 439, 541, 540, 1003, 4651, 4653, 4649, 6941, 5707, 5706,
+3671, 703, 1317, 1331, 1335, 6699, 3282, 6942, 6664, 3283, 1716,
+3672, 1251, 1238, 755, 1300, 3321, 6944, 6943, 3479, 3478, 6813,
+3673, 306, 104, 140, 855, 3911, 3667, 6428, 6430, 6945, 1937,
+3674, 1286, 1228, 606, 619, 3498, 6678, 6067, 6946, 6679, 4916,
+3675, 306, 105, 140, 104, 3912, 3668, 6428, 3911, 1554, 3667,
+3676, 408, 986, 407, 261, 6948, 6947, 4222, 4220, 6949, 4218,
+3677, 1198, 619, 1286, 1271, 6704, 6946, 3436, 3386, 6950, 3437,
+3678, 439, 1004, 540, 438, 6952, 6951, 4649, 4316, 6953, 4648,
+3679, 429, 842, 923, 284, 6954, 2222, 5714, 4284, 6955, 5765,
+3680, 924, 114, 84, 115, 2124, 3621, 6956, 2123, 1468, 3622,
+3681, 1364, 1356, 742, 772, 1634, 6957, 6484, 6482, 6958, 5465,
+3682, 1302, 614, 648, 668, 6774, 5008, 6487, 6488, 5084, 5083,
+3683, 287, 116, 925, 843, 6959, 2126, 5874, 6960, 1913, 2178,
+3684, 209, 267, 914, 832, 6671, 5548, 2100, 1890, 5549, 2201,
+3685, 205, 882, 60, 883, 2016, 6733, 6649, 2018, 2020, 6650,
+3686, 296, 931, 441, 849, 5566, 5564, 4320, 6909, 2184, 6908,
+3687, 611, 577, 581, 1212, 4892, 4796, 4893, 6382, 6718, 5511,
+3688, 127, 930, 94, 126, 2136, 6961, 3644, 1480, 2137, 3643,
+3689, 183, 860, 38, 861, 1950, 6530, 5923, 1952, 1954, 6146,
+3690, 917, 215, 1376, 835, 2106, 6963, 6962, 2204, 1896, 6964,
+3691, 463, 489, 1133, 564, 4480, 5947, 5945, 4718, 4717, 6965,
+3692, 279, 971, 425, 278, 6869, 6819, 4272, 3832, 6821, 4271,
+3693, 425, 971, 920, 278, 6819, 2571, 5893, 4271, 6821, 5894,
+3694, 1291, 762, 1326, 1346, 6445, 6446, 2689, 2688, 6921, 1717,
+3695, 238, 36, 900, 35, 3708, 5569, 5568, 3707, 1559, 6188,
+3696, 128, 127, 296, 94, 1481, 6910, 5574, 3645, 3644, 3881,
+3697, 647, 564, 1230, 552, 5040, 6966, 6560, 5002, 4720, 6967,
+3698, 1298, 1305, 659, 1341, 3089, 6968, 6788, 3090, 1742, 6789,
+3699, 1354, 770, 1343, 756, 6364, 6969, 1673, 6282, 5432, 6970,
+3700, 1107, 508, 622, 509, 6017, 4819, 6018, 6971, 4551, 4820,
+3701, 760, 1334, 758, 743, 6973, 6972, 5397, 5394, 6974, 5389,
+3702, 1194, 1248, 591, 1224, 3310, 6975, 6607, 3195, 3311, 6976,
+3703, 329, 971, 425, 279, 6977, 6819, 4273, 3962, 6869, 4272,
+3704, 329, 971, 815, 425, 6977, 2324, 6122, 4273, 6819, 6978,
+3705, 182, 860, 38, 183, 1949, 6530, 6979, 1419, 1950, 5923,
+3706, 37, 344, 38, 860, 3996, 3998, 1561, 5804, 6468, 6530,
+3707, 182, 183, 38, 901, 1419, 5923, 6979, 2075, 2074, 6163,
+3708, 1027, 871, 314, 1026, 2485, 6621, 6980, 2487, 2483, 6981,
+3709, 826, 909, 198, 255, 2164, 2091, 1877, 6982, 6983, 6452,
+3710, 350, 871, 314, 48, 6984, 6621, 4084, 4012, 6586, 3929,
+3711, 834, 69, 272, 917, 6211, 3809, 6209, 2172, 6986, 6985,
+3712, 939, 784, 224, 783, 2229, 5700, 6987, 2228, 1760, 6988,
+3713, 1296, 1268, 614, 1302, 3472, 6470, 6471, 3486, 3485, 6774,
+3714, 509, 508, 398, 1102, 4551, 4547, 4549, 6989, 6991, 6990,
+3715, 778, 1370, 769, 1372, 6993, 6992, 5474, 6994, 1626, 6473,
+3716, 870, 871, 350, 48, 1984, 6984, 6780, 6995, 6586, 4012,
+3717, 230, 799, 20, 161, 6996, 6779, 3688, 6785, 1803, 3575,
+3718, 399, 1102, 509, 398, 6997, 6989, 4550, 4195, 6990, 4549,
+3719, 230, 336, 953, 798, 4077, 6998, 5606, 6999, 7000, 2271,
+3720, 329, 971, 279, 816, 6977, 6869, 3962, 6119, 2325, 6121,
+3721, 716, 1278, 718, 1279, 7002, 7001, 5237, 7003, 3443, 7004,
+3722, 965, 809, 484, 964, 2306, 6318, 7005, 2308, 2304, 7006,
+3723, 891, 1047, 1046, 324, 2545, 2547, 2543, 6641, 7007, 6640,
+3724, 824, 48, 251, 49, 7009, 3746, 7008, 7010, 1572, 3747,
+3725, 361, 1048, 892, 1047, 6868, 2548, 7011, 7012, 2550, 2546,
+3726, 506, 396, 1058, 395, 4541, 6918, 6766, 4540, 4186, 7013,
+3727, 341, 809, 28, 234, 6317, 7014, 3988, 4054, 6319, 3696,
+3728, 892, 1047, 891, 324, 2546, 2545, 2047, 7015, 7007, 6641,
+3729, 1277, 1345, 671, 713, 2697, 7016, 5560, 7017, 7018, 5299,
+3730, 669, 612, 1214, 1282, 5087, 7019, 6050, 6048, 7020, 3424,
+3731, 1365, 764, 1362, 1368, 6932, 6108, 1637, 1638, 6448, 1625,
+3732, 396, 250, 397, 906, 4185, 4187, 4189, 6546, 7021, 6545,
+3733, 966, 378, 967, 1095, 7023, 7022, 2314, 2733, 6295, 2735,
+3734, 273, 71, 1376, 70, 3813, 7025, 7024, 3812, 1594, 7026,
+3735, 889, 323, 359, 66, 6181, 4093, 5818, 5819, 3947, 4030,
+3736, 121, 927, 846, 291, 2129, 2131, 1920, 7027, 7029, 7028,
+3737, 493, 1093, 964, 377, 7031, 2726, 7030, 4506, 7033, 7032,
+3738, 242, 40, 902, 39, 3720, 7035, 7034, 3719, 1563, 7036,
+3739, 1288, 667, 1306, 1293, 6743, 6392, 3231, 3526, 6744, 3041,
+3740, 361, 70, 892, 893, 4034, 7037, 7011, 7038, 7039, 2050,
+3741, 823, 906, 47, 250, 2161, 7041, 7040, 7042, 7021, 3743,
+3742, 780, 775, 768, 1359, 5491, 5489, 5493, 6406, 6299, 6263,
+3743, 1271, 586, 1227, 652, 6685, 5610, 3385, 6698, 5028, 6702,
+3744, 500, 499, 1184, 609, 4523, 5682, 6843, 4887, 4886, 6661,
+3745, 386, 818, 240, 997, 7043, 6835, 4155, 7044, 2397, 6836,
+3746, 1298, 1303, 661, 1261, 3407, 7045, 6723, 3470, 3516, 6725,
+3747, 1101, 591, 517, 516, 6513, 4826, 5591, 6816, 4825, 4577,
+3748, 713, 1357, 766, 1333, 7047, 7046, 5420, 7048, 1693, 7049,
+3749, 814, 425, 969, 236, 5612, 7050, 2319, 5613, 4439, 7051,
+3750, 811, 810, 29, 235, 1841, 7053, 7052, 6039, 7054, 3699,
+3751, 1196, 1225, 1195, 644, 3199, 3356, 3313, 6082, 6083, 7055,
+3752, 1027, 871, 351, 314, 2485, 6589, 6567, 6980, 6621, 4061,
+3753, 918, 993, 420, 835, 2385, 6916, 7056, 2173, 2386, 7057,
+3754, 824, 906, 980, 251, 2193, 2350, 2349, 7008, 7059, 7058,
+3755, 1284, 686, 1221, 1259, 6570, 7060, 3442, 3446, 6289, 3358,
+3756, 1007, 442, 1068, 543, 7062, 7061, 2628, 7063, 4658, 6514,
+3757, 1102, 1113, 400, 510, 2925, 5739, 5737, 5659, 5660, 4553,
+3758, 336, 798, 160, 797, 7000, 1800, 7064, 7065, 1802, 1798,
+3759, 274, 918, 836, 993, 6670, 2205, 6668, 7066, 2385, 2387,
+3760, 987, 410, 409, 517, 5921, 4228, 5885, 5592, 4578, 4576,
+3761, 917, 70, 1376, 215, 7067, 7026, 6962, 2106, 7068, 6963,
+3762, 1376, 216, 918, 835, 7070, 2109, 7069, 6964, 1895, 2173,
+3763, 286, 431, 430, 843, 4290, 4292, 4288, 5882, 7071, 5881,
+3764, 275, 993, 1062, 421, 7073, 2604, 7072, 4260, 7074, 6064,
+3765, 275, 993, 836, 1062, 7073, 2387, 7075, 7072, 2604, 2603,
+3766, 1376, 215, 893, 216, 6963, 2048, 7076, 7070, 1452, 2049,
+3767, 616, 1207, 1076, 575, 5554, 3106, 7077, 5142, 7078, 5890,
+3768, 834, 69, 214, 68, 6211, 7079, 1893, 6271, 1592, 6783,
+3769, 704, 1306, 1288, 667, 6203, 3231, 6371, 5194, 6392, 6743,
+3770, 10, 787, 149, 225, 7080, 1767, 3553, 3678, 7081, 5575,
+3771, 789, 226, 944, 788, 7082, 6221, 2244, 1775, 6030, 2243,
+3772, 274, 993, 275, 421, 7066, 7073, 3820, 4259, 7074, 4260,
+3773, 155, 334, 793, 792, 6806, 6385, 1785, 1783, 7083, 1787,
+3774, 968, 1096, 529, 1097, 2738, 5661, 5810, 2740, 2742, 5722,
+3775, 528, 1095, 596, 1218, 7085, 7084, 4840, 6922, 3161, 6496,
+3776, 836, 993, 275, 274, 2387, 7073, 7075, 6668, 7066, 3820,
+3777, 438, 1004, 539, 437, 6953, 7086, 4646, 4313, 6839, 4645,
+3778, 539, 1004, 1000, 437, 7086, 2419, 7087, 4645, 6839, 6837,
+3779, 331, 786, 382, 225, 7089, 7088, 4144, 3991, 7090, 4143,
+3780, 1307, 1201, 605, 1267, 3504, 6532, 6770, 1735, 3463, 7091,
+3781, 348, 455, 1021, 311, 4365, 6663, 7092, 4058, 4366, 7093,
+3782, 1365, 776, 777, 1338, 7094, 5482, 6491, 1666, 7095, 6492,
+3783, 380, 1017, 1119, 1018, 7096, 2806, 5954, 7097, 2460, 2807,
+3784, 382, 786, 331, 941, 7088, 7089, 4144, 7098, 2235, 7099,
+3785, 953, 797, 336, 952, 2270, 7065, 6998, 2272, 2268, 6742,
+3786, 9, 225, 149, 786, 3679, 5575, 3550, 7100, 7090, 1765,
+3787, 450, 343, 1011, 306, 4440, 7102, 7101, 4348, 4356, 7103,
+3788, 165, 802, 22, 338, 1813, 7104, 3579, 6279, 7105, 3982,
+3789, 28, 809, 171, 234, 7014, 1833, 3593, 3696, 6319, 6160,
+3790, 37, 182, 181, 859, 6423, 1418, 7106, 5802, 1947, 1946,
+3791, 568, 1095, 584, 378, 5639, 5649, 4877, 4878, 6295, 4802,
+3792, 149, 148, 9, 786, 1384, 3551, 3550, 1765, 1764, 7100,
+3793, 275, 72, 836, 274, 3818, 6669, 7075, 3820, 3816, 6668,
+3794, 815, 814, 177, 32, 1853, 1849, 1851, 6605, 7107, 3601,
+3795, 484, 810, 965, 378, 7108, 2307, 7005, 4456, 7109, 6294,
+3796, 1151, 1049, 473, 1150, 2902, 6608, 7110, 2904, 2900, 7111,
+3797, 382, 786, 942, 225, 7088, 2237, 7112, 4143, 7090, 7113,
+3798, 991, 1103, 416, 1061, 2755, 7115, 7114, 2648, 2756, 7116,
+3799, 953, 336, 372, 952, 6998, 4123, 7117, 2272, 6742, 6740,
+3800, 942, 786, 382, 941, 2237, 7088, 7112, 2239, 2235, 7098,
+3801, 76, 838, 77, 279, 6824, 7118, 1600, 3830, 6823, 3831,
+3802, 177, 814, 176, 32, 1849, 1848, 1412, 3601, 7107, 3602,
+3803, 219, 220, 75, 837, 1456, 7120, 7119, 1900, 1899, 7121,
+3804, 78, 839, 108, 280, 6505, 1905, 3609, 3834, 6353, 6635,
+3805, 341, 809, 484, 810, 6317, 6318, 4453, 7122, 1838, 7108,
+3806, 689, 589, 1253, 588, 5154, 7124, 7123, 5153, 4818, 7125,
+3807, 920, 970, 425, 424, 2916, 6818, 5893, 5626, 5896, 4274,
+3808, 1292, 608, 1197, 586, 6058, 6012, 3455, 6686, 4885, 5657,
+3809, 1166, 1170, 540, 1004, 2977, 7126, 5704, 2955, 2975, 6951,
+3810, 670, 1315, 712, 1304, 6055, 7127, 5217, 7128, 1740, 7129,
+3811, 41, 310, 347, 864, 3920, 4057, 4007, 7130, 5642, 5793,
+3812, 540, 1170, 539, 1004, 7126, 7131, 4650, 6951, 2975, 7086,
+3813, 416, 270, 991, 1061, 4245, 7132, 7114, 7116, 7133, 2648,
+3814, 18, 797, 160, 159, 6591, 1798, 3570, 3571, 1797, 1395,
+3815, 160, 797, 18, 336, 1798, 6591, 3570, 7064, 7065, 3978,
+3816, 550, 1137, 1231, 1200, 7135, 3226, 7134, 7136, 3228, 3229,
+3817, 483, 1093, 493, 377, 7137, 7031, 4507, 4501, 7033, 4506,
+3818, 27, 808, 340, 234, 6323, 6776, 3985, 3697, 6324, 4081,
+3819, 880, 58, 319, 355, 5596, 3939, 5594, 6325, 4022, 4089,
+3820, 60, 882, 320, 883, 6733, 7138, 3941, 6650, 2020, 6673,
+3821, 963, 1093, 483, 377, 2724, 7137, 7139, 7140, 7033, 4501,
+3822, 808, 377, 484, 964, 6777, 4455, 7141, 2303, 7032, 7006,
+3823, 1325, 1336, 759, 719, 3271, 7143, 7142, 6736, 7144, 5392,
+3824, 242, 39, 902, 819, 3719, 7036, 7034, 7145, 7146, 2220,
+3825, 1145, 1043, 1044, 470, 2884, 2538, 2885, 6431, 6715, 7147,
+3826, 521, 520, 1182, 629, 4591, 6363, 7148, 4944, 4943, 7149,
+3827, 1221, 631, 525, 524, 7151, 4834, 7150, 7152, 4948, 4603,
+3828, 1221, 524, 1110, 1219, 7152, 5936, 3180, 3181, 7153, 3165,
+3829, 976, 819, 241, 974, 2337, 6149, 6077, 2339, 2333, 6201,
+3830, 424, 994, 423, 277, 5628, 6689, 4270, 4268, 7154, 4266,
+3831, 111, 81, 282, 283, 3615, 3840, 7155, 7156, 3842, 3844,
+3832, 241, 819, 242, 974, 6149, 7145, 3721, 6201, 2333, 5677,
+3833, 285, 842, 284, 83, 7157, 6955, 3850, 3848, 7158, 3846,
+3834, 935, 1009, 447, 853, 2430, 5724, 7159, 2188, 2431, 5725,
+3835, 100, 101, 302, 135, 1550, 3900, 3899, 3658, 3659, 7160,
+3836, 119, 845, 88, 289, 1918, 7161, 3630, 7162, 7163, 3861,
+3837, 548, 447, 448, 1009, 4673, 4343, 4674, 5664, 5724, 5663,
+3838, 110, 840, 922, 282, 1907, 2221, 2120, 7164, 7166, 7165,
+3839, 242, 819, 902, 974, 7145, 2220, 7034, 5677, 2333, 2332,
+3840, 436, 292, 846, 291, 4306, 7168, 7167, 4305, 3871, 7028,
+3841, 426, 569, 1154, 972, 4738, 5789, 7169, 7170, 7171, 2915,
+3842, 582, 1225, 617, 1226, 6194, 6628, 5023, 6809, 3256, 6808,
+3843, 444, 1008, 933, 445, 5768, 2429, 5766, 4334, 7173, 7172,
+3844, 443, 850, 1007, 442, 6936, 2427, 7174, 4328, 6940, 7062,
+3845, 264, 830, 206, 913, 6935, 1885, 6934, 6712, 2168, 2099,
+3846, 1065, 435, 1054, 927, 6421, 7175, 2615, 2616, 6456, 2569,
+3847, 704, 666, 1288, 1320, 5197, 6746, 6371, 6372, 7176, 3233,
+3848, 1000, 436, 437, 928, 7177, 4310, 6837, 2407, 7179, 7178,
+3849, 539, 438, 540, 1004, 4646, 4648, 4650, 7086, 6953, 6951,
+3850, 308, 456, 452, 1015, 4367, 4370, 4355, 6558, 6117, 5534,
+3851, 853, 101, 136, 135, 7180, 3660, 1933, 1934, 3659, 1489,
+3852, 1172, 641, 545, 544, 7181, 4982, 6253, 7182, 4980, 4666,
+3853, 682, 737, 1332, 733, 5319, 7183, 5869, 5303, 5385, 7184,
+3854, 1007, 850, 1068, 442, 2427, 2626, 2628, 7062, 6940, 7061,
+3855, 987, 830, 264, 913, 2370, 6935, 7185, 2369, 2168, 6712,
+3856, 77, 838, 221, 222, 7118, 1902, 7186, 6162, 1901, 1458,
+3857, 331, 784, 940, 785, 5668, 2231, 5772, 5669, 1763, 2232,
+3858, 809, 808, 171, 234, 1835, 1831, 1833, 6319, 6324, 6160,
+3859, 76, 898, 364, 328, 5846, 5842, 4040, 3957, 5845, 4098,
+3860, 408, 1105, 986, 1060, 6706, 2760, 6948, 5813, 2759, 2595,
+3861, 1375, 34, 78, 1, 6506, 3833, 6504, 7187, 1557, 1527,
+3862, 1078, 570, 1077, 368, 5584, 7188, 2674, 5585, 4742, 5743,
+3863, 936, 305, 449, 1010, 7189, 4345, 6617, 2432, 7190, 5808,
+3864, 383, 1076, 1077, 944, 5904, 2671, 7191, 5701, 2667, 2669,
+3865, 923, 841, 428, 284, 2176, 5711, 5764, 5765, 5712, 4282,
+3866, 999, 365, 1005, 1014, 5898, 5899, 2610, 2792, 7192, 2643,
+3867, 456, 365, 999, 1014, 4369, 5898, 7193, 6116, 7192, 2792,
+3868, 1005, 365, 345, 1014, 5899, 4109, 6576, 2643, 7192, 7194,
+3869, 231, 164, 22, 21, 7195, 3580, 3690, 3691, 3578, 1514,
+3870, 1209, 598, 1210, 610, 6390, 6388, 3120, 5618, 4889, 7196,
+3871, 836, 73, 218, 72, 7197, 6097, 1897, 6669, 1596, 7198,
+3872, 381, 1027, 314, 1026, 7199, 6980, 4141, 7200, 2487, 6981,
+3873, 275, 73, 836, 72, 3819, 7197, 7075, 3818, 1596, 6669,
+3874, 804, 805, 339, 167, 1823, 5496, 5615, 1819, 1821, 6759,
+3875, 955, 1085, 373, 1086, 2700, 5621, 5914, 2702, 2704, 7201,
+3876, 264, 913, 265, 988, 6712, 6713, 3790, 6898, 2372, 6897,
+3877, 381, 314, 350, 1026, 4141, 4084, 4142, 7200, 6981, 7202,
+3878, 931, 442, 1068, 850, 7203, 7061, 2624, 2212, 6940, 2626,
+3879, 21, 800, 162, 337, 7204, 1806, 3577, 3979, 5966, 6778,
+3880, 21, 162, 20, 337, 3577, 3574, 1513, 3979, 6778, 3980,
+3881, 449, 305, 450, 1010, 4345, 4347, 4349, 5808, 7190, 6433,
+3882, 100, 135, 934, 134, 3658, 2144, 7205, 3657, 1488, 2145,
+3883, 1265, 1327, 1273, 752, 3448, 3170, 3393, 6394, 7206, 6901,
+3884, 1253, 1193, 1239, 589, 3327, 3275, 3328, 7124, 7208, 7207,
+3885, 903, 821, 187, 42, 2155, 1868, 2078, 6655, 7210, 7209,
+3886, 441, 442, 1068, 931, 4325, 7061, 6222, 5564, 7203, 2624,
+3887, 1121, 1020, 1122, 458, 2813, 2815, 2817, 7211, 6086, 6301,
+3888, 309, 453, 380, 1017, 4358, 4361, 4140, 7212, 7213, 7096,
+3889, 353, 1032, 463, 489, 7214, 5946, 4392, 4479, 5948, 4480,
+3890, 100, 301, 934, 302, 3897, 7215, 7205, 3899, 3901, 7216,
+3891, 991, 270, 271, 916, 7132, 3808, 7217, 2381, 6196, 7218,
+3892, 473, 558, 474, 1152, 4698, 4697, 4493, 7219, 7220, 6597,
+3893, 837, 994, 424, 277, 2388, 5628, 6332, 7221, 7154, 4268,
+3894, 301, 852, 133, 134, 7223, 1932, 7222, 7224, 1931, 1487,
+3895, 1263, 585, 1175, 1207, 6358, 7225, 3376, 3396, 5906, 3107,
+3896, 934, 301, 446, 302, 7215, 4335, 7226, 7216, 3901, 4336,
+3897, 1360, 1355, 736, 1371, 1644, 6512, 5978, 1645, 1608, 6667,
+3898, 187, 821, 188, 42, 1868, 1867, 1424, 7209, 7210, 5779,
+3899, 617, 608, 1264, 654, 4910, 6011, 7227, 5039, 5038, 7228,
+3900, 1089, 959, 1090, 494, 2712, 2714, 2716, 7229, 5531, 5530,
+3901, 1097, 970, 920, 424, 2917, 2916, 2784, 5627, 5896, 5626,
+3902, 402, 1059, 909, 983, 7231, 2592, 7230, 7232, 2646, 2359,
+3903, 968, 813, 342, 812, 2316, 5916, 5915, 2315, 1847, 6722,
+3904, 670, 654, 712, 1315, 5089, 5218, 5217, 6055, 7233, 7127,
+3905, 781, 899, 77, 328, 2152, 6062, 6045, 6047, 5848, 3956,
+3906, 356, 1037, 319, 466, 7235, 7234, 4066, 4402, 7236, 4400,
+3907, 67, 889, 66, 323, 7237, 5819, 1590, 3946, 6181, 3947,
+3908, 1123, 1021, 1022, 455, 2818, 2472, 2819, 5748, 6663, 5747,
+3909, 41, 310, 864, 863, 3920, 5642, 7130, 7238, 5643, 1963,
+3910, 833, 269, 268, 990, 6805, 3802, 6830, 2379, 7239, 6831,
+3911, 1271, 619, 714, 652, 6950, 5222, 7240, 6698, 5029, 5223,
+3912, 231, 481, 374, 957, 4446, 4495, 4128, 7241, 7242, 6646,
+3913, 67, 323, 890, 889, 3946, 7244, 7243, 7237, 6181, 2041,
+3914, 470, 359, 1044, 323, 4411, 6483, 7147, 4413, 4093, 6178,
+3915, 779, 1369, 1371, 1367, 7245, 1631, 6525, 6538, 1629, 1632,
+3916, 890, 323, 67, 360, 7244, 3946, 7243, 7246, 4070, 4033,
+3917, 889, 1044, 359, 323, 2537, 6483, 5818, 6181, 6178, 4093,
+3918, 228, 794, 371, 335, 5959, 7247, 4122, 4048, 5961, 4121,
+3919, 401, 826, 402, 1059, 5991, 7248, 4204, 5993, 2590, 7231,
+3920, 698, 618, 1272, 685, 5177, 6904, 5777, 5176, 5136, 7249,
+3921, 1373, 59, 882, 204, 6927, 6928, 6731, 7250, 7251, 2015,
+3922, 1200, 604, 550, 614, 7252, 4869, 7136, 6469, 5005, 4900,
+3923, 698, 1307, 658, 677, 5775, 5774, 5273, 5274, 7253, 5109,
+3924, 346, 863, 1018, 310, 7255, 2459, 7254, 4105, 5643, 7256,
+3925, 715, 675, 1321, 750, 5228, 5987, 7257, 5354, 5353, 7258,
+3926, 47, 192, 870, 193, 7259, 1979, 6781, 7260, 1429, 1980,
+3927, 275, 919, 836, 73, 7261, 2174, 7075, 3819, 6028, 7197,
+3928, 326, 1050, 1051, 895, 6691, 2559, 7262, 6683, 2555, 2557,
+3929, 381, 1127, 1128, 1026, 7264, 2835, 7263, 7200, 2831, 2833,
+3930, 451, 1019, 384, 310, 7265, 5950, 4353, 4350, 5641, 4151,
+3931, 474, 1050, 473, 1152, 6598, 7266, 4493, 6597, 2905, 7219,
+3932, 186, 863, 41, 864, 1959, 7238, 5751, 1961, 1963, 7130,
+3933, 374, 1088, 958, 957, 7267, 2709, 6000, 6646, 2708, 2287,
+3934, 1320, 666, 1288, 1275, 7176, 6746, 3233, 3536, 6342, 3264,
+3935, 41, 863, 186, 40, 7238, 1959, 5751, 1564, 7268, 5901,
+3936, 197, 874, 52, 875, 1992, 6874, 7269, 1994, 1996, 6875,
+3937, 924, 285, 286, 84, 6771, 3853, 5883, 6956, 3849, 3851,
+3938, 874, 52, 316, 352, 6874, 3933, 6873, 7270, 4016, 4086,
+3939, 190, 46, 45, 905, 7271, 1569, 6775, 2083, 6462, 6657,
+3940, 934, 446, 447, 302, 7226, 4340, 7272, 7216, 4336, 4338,
+3941, 505, 1239, 1193, 589, 6313, 3275, 6091, 4817, 7207, 7208,
+3942, 196, 874, 52, 197, 1991, 6874, 7273, 1433, 1992, 7269,
+3943, 196, 197, 52, 908, 1433, 7269, 7273, 2089, 2088, 7274,
+3944, 639, 542, 1099, 541, 4974, 7275, 6041, 4973, 4656, 6665,
+3945, 700, 710, 1256, 1289, 5312, 7277, 7276, 7278, 7279, 3449,
+3946, 52, 51, 352, 874, 1575, 4017, 4016, 6874, 7280, 7270,
+3947, 314, 871, 350, 1026, 6621, 6984, 4084, 6981, 2483, 7202,
+3948, 62, 357, 885, 884, 4026, 7282, 7281, 7283, 6652, 2026,
+3949, 722, 1347, 731, 728, 7285, 7284, 5294, 5279, 7286, 5372,
+3950, 780, 777, 1329, 1359, 5488, 7288, 7287, 6406, 6493, 1677,
+3951, 357, 62, 885, 321, 4026, 7281, 7282, 4091, 3943, 7289,
+3952, 1154, 972, 999, 426, 2915, 2405, 2914, 7169, 7170, 7290,
+3953, 768, 764, 1365, 1368, 5429, 6932, 6265, 6264, 6448, 1638,
+3954, 63, 885, 62, 321, 7291, 7281, 1586, 3942, 7289, 3943,
+3955, 42, 311, 865, 347, 3923, 7292, 5781, 4006, 4102, 5791,
+3956, 284, 112, 923, 841, 7293, 2122, 5765, 5712, 1909, 2176,
+3957, 950, 496, 479, 951, 6891, 4512, 7294, 2266, 7296, 7295,
+3958, 881, 1037, 356, 882, 2515, 7235, 7297, 2017, 2516, 7298,
+3959, 1138, 487, 1137, 1036, 6412, 7299, 2865, 2863, 5506, 2861,
+3960, 174, 235, 812, 811, 6147, 7300, 1842, 1840, 6039, 1844,
+3961, 21, 801, 164, 163, 7301, 1810, 3578, 3576, 1809, 1399,
+3962, 945, 368, 1078, 1077, 5744, 5585, 2672, 2670, 5743, 2674,
+3963, 1342, 751, 1339, 1366, 7302, 6913, 1665, 1662, 6416, 1664,
+3964, 493, 596, 568, 1094, 4906, 4905, 4735, 7303, 5527, 5640,
+3965, 219, 896, 327, 897, 2058, 7305, 7304, 2060, 2062, 7306,
+3966, 219, 896, 74, 327, 2058, 7308, 7307, 7304, 7305, 3955,
+3967, 243, 820, 41, 244, 6154, 5753, 3723, 3727, 6529, 3725,
+3968, 679, 1256, 1240, 1237, 6853, 3349, 7309, 7310, 3339, 3279,
+3969, 768, 776, 1365, 1351, 5462, 7094, 6265, 7311, 7312, 1648,
+3970, 896, 1052, 327, 897, 2560, 5940, 7305, 2062, 2561, 7306,
+3971, 1090, 1215, 583, 571, 3146, 6561, 6216, 7313, 6841, 4799,
+3972, 512, 1104, 1116, 983, 7314, 2799, 6459, 7315, 2758, 2797,
+3973, 74, 896, 363, 327, 7308, 7316, 4038, 3955, 7305, 4097,
+3974, 482, 338, 802, 803, 4449, 7105, 7317, 6164, 6280, 1817,
+3975, 1184, 499, 601, 609, 5682, 4857, 5680, 6661, 4886, 4888,
+3976, 909, 983, 403, 402, 2359, 6478, 6647, 7230, 7232, 4207,
+3977, 459, 1126, 567, 1127, 7319, 7318, 4731, 7320, 2832, 7321,
+3978, 219, 73, 74, 896, 6098, 1597, 7307, 2058, 7322, 7308,
+3979, 1199, 1230, 647, 555, 3076, 6560, 6559, 7323, 7324, 4999,
+3980, 1174, 1181, 590, 1116, 3015, 5577, 6457, 2993, 3013, 6281,
+3981, 74, 73, 363, 896, 1597, 4039, 4038, 7308, 7322, 7316,
+3982, 194, 49, 824, 907, 7325, 7010, 1873, 2087, 7326, 2162,
+3983, 1033, 1032, 317, 489, 2505, 7328, 7327, 7329, 5948, 4481,
+3984, 50, 907, 194, 195, 7331, 2087, 7330, 6626, 2086, 1431,
+3985, 50, 907, 252, 49, 7331, 6761, 3750, 1573, 7326, 3749,
+3986, 49, 252, 824, 907, 3749, 7332, 7010, 7326, 6761, 2162,
+3987, 252, 49, 824, 251, 3749, 7010, 7332, 3751, 3747, 7008,
+3988, 990, 414, 267, 832, 6019, 4238, 7333, 2378, 5859, 5549,
+3989, 1089, 1088, 958, 494, 2713, 2709, 2711, 7229, 7334, 6002,
+3990, 279, 838, 77, 816, 6823, 7118, 3831, 6121, 1903, 6120,
+3991, 372, 952, 229, 479, 6740, 6741, 4124, 4499, 7335, 4442,
+3992, 22, 802, 231, 338, 7104, 7336, 3690, 3982, 7105, 4051,
+3993, 1275, 666, 1288, 1274, 6342, 6746, 3264, 3263, 5762, 1746,
+3994, 485, 378, 584, 967, 4496, 4802, 4801, 7337, 7022, 5647,
+3995, 1376, 71, 918, 216, 7025, 7338, 7069, 7070, 5674, 2109,
+3996, 1376, 835, 918, 273, 6964, 2173, 7069, 7024, 7340, 7339,
+3997, 77, 222, 221, 899, 6162, 1458, 7186, 6062, 2067, 2066,
+3998, 969, 970, 424, 425, 2323, 5896, 5895, 7050, 6818, 4274,
+3999, 529, 379, 968, 1097, 4727, 5812, 5810, 5722, 5794, 2740,
+4000, 935, 448, 447, 1009, 6123, 4343, 7159, 2430, 5663, 5724,
+4001, 435, 290, 1066, 434, 4302, 6453, 6454, 4304, 4300, 7341,
+4002, 273, 71, 274, 918, 3813, 3815, 3817, 7339, 7338, 6670,
+4003, 240, 818, 386, 239, 6835, 7043, 4155, 3715, 7342, 4154,
+4004, 130, 932, 298, 850, 2141, 5740, 7343, 1927, 2185, 5833,
+4005, 956, 800, 801, 481, 2279, 1811, 2280, 5623, 5873, 5872,
+4006, 968, 379, 969, 1097, 5812, 7344, 2320, 2740, 5794, 2741,
+4007, 1107, 1179, 622, 1193, 3027, 7345, 6018, 3051, 3176, 7346,
+4008, 425, 379, 969, 236, 4460, 7344, 7050, 4439, 4137, 7051,
+4009, 1134, 1032, 1033, 489, 2851, 2505, 2852, 5958, 5948, 7329,
+4010, 1054, 436, 846, 435, 7347, 7167, 2568, 7175, 4307, 7348,
+4011, 1063, 534, 535, 431, 7349, 4633, 5910, 5912, 4629, 4631,
+4012, 918, 835, 420, 273, 2173, 7057, 7056, 7339, 7340, 4256,
+4013, 1161, 574, 1189, 531, 5957, 5955, 3038, 6230, 4803, 6229,
+4014, 350, 871, 870, 1026, 6984, 1984, 6780, 7202, 2483, 2482,
+4015, 886, 885, 321, 1041, 2029, 7289, 7350, 2528, 2527, 7351,
+4016, 466, 1037, 319, 1036, 7236, 7234, 4400, 7352, 2517, 7353,
+4017, 1144, 1043, 1145, 486, 2882, 2884, 2886, 7354, 6716, 6432,
+4018, 846, 292, 122, 291, 7168, 7355, 1919, 7028, 3871, 7356,
+4019, 317, 1032, 353, 489, 7328, 7214, 4087, 4481, 5948, 4479,
+4020, 525, 1108, 1110, 992, 7358, 2776, 7357, 7359, 2769, 2773,
+4021, 601, 643, 1249, 609, 4989, 7361, 7360, 4888, 5072, 6884,
+4022, 1331, 698, 703, 721, 6582, 5192, 6942, 6554, 5249, 5248,
+4023, 1266, 1247, 656, 720, 3375, 5786, 5785, 7362, 6234, 5245,
+4024, 36, 900, 818, 239, 5569, 2219, 7363, 3710, 5567, 7342,
+4025, 726, 700, 689, 1289, 5271, 5193, 5272, 7364, 7278, 7365,
+4026, 439, 929, 438, 294, 7367, 7366, 4316, 4314, 6937, 4312,
+4027, 537, 1054, 538, 635, 7368, 6311, 4643, 4961, 6304, 4962,
+4028, 848, 929, 439, 294, 2210, 7367, 7369, 7370, 6937, 4314,
+4029, 546, 1069, 446, 1070, 5735, 7371, 4668, 6871, 2652, 6872,
+4030, 1250, 643, 1249, 1169, 7372, 7361, 3348, 3293, 6258, 3316,
+4031, 1000, 436, 538, 437, 7177, 4642, 7373, 6837, 4310, 4644,
+4032, 547, 643, 546, 1169, 4987, 4986, 4672, 6257, 6258, 6300,
+4033, 438, 293, 294, 929, 4311, 3877, 4312, 7366, 7374, 6937,
+4034, 601, 643, 1165, 1249, 4989, 6075, 6076, 7360, 7361, 3315,
+4035, 1184, 609, 1249, 1269, 6661, 6884, 3337, 3381, 6885, 3413,
+4036, 1254, 1289, 1253, 688, 3451, 3457, 3333, 7375, 7377, 7376,
+4037, 748, 734, 1255, 1252, 5369, 7379, 7378, 6784, 6246, 3336,
+4038, 550, 1137, 1200, 1138, 7135, 3228, 7136, 6411, 2865, 3079,
+4039, 901, 240, 241, 38, 6834, 3718, 6148, 6163, 3714, 3716,
+4040, 447, 1070, 547, 446, 5726, 5731, 4671, 4340, 6872, 4670,
+4041, 1298, 645, 1285, 1261, 6724, 5539, 3469, 3470, 5541, 3435,
+4042, 847, 293, 438, 929, 7381, 4311, 7380, 2182, 7374, 7366,
+4043, 1056, 391, 503, 392, 7383, 4530, 7382, 7384, 4174, 4531,
+4044, 1231, 1136, 553, 1135, 3078, 7386, 7385, 3077, 2859, 7387,
+4045, 1319, 724, 702, 742, 7388, 5263, 6005, 6466, 5329, 5328,
+4046, 109, 80, 281, 840, 3612, 3837, 7389, 1908, 7390, 5696,
+4047, 199, 256, 909, 827, 6407, 6648, 2090, 1880, 6408, 2196,
+4048, 391, 973, 1056, 1114, 7391, 2577, 7383, 5862, 2789, 2791,
+4049, 955, 1086, 373, 481, 2702, 7201, 5914, 5624, 5625, 4461,
+4050, 957, 802, 231, 801, 2283, 7336, 7241, 2282, 1814, 5870,
+4051, 1196, 1118, 574, 1206, 3061, 7393, 7392, 3175, 3103, 5956,
+4052, 331, 148, 147, 785, 7394, 1383, 5667, 5669, 1762, 1761,
+4053, 357, 884, 1040, 885, 6652, 2524, 7395, 7282, 2026, 2525,
+4054, 961, 1092, 483, 962, 2720, 7397, 7396, 2299, 2721, 7398,
+4055, 358, 886, 1041, 1042, 6187, 2528, 7399, 7400, 2530, 2532,
+4056, 892, 324, 361, 1047, 7015, 4071, 7011, 2546, 7007, 7012,
+4057, 1196, 644, 1189, 574, 6082, 6548, 3314, 7392, 4992, 5955,
+4058, 602, 486, 1144, 576, 4859, 7354, 7401, 4861, 4769, 5599,
+4059, 814, 32, 815, 329, 7107, 6605, 1853, 5611, 3961, 6122,
+4060, 989, 413, 1055, 832, 7402, 5858, 2574, 2376, 5547, 2573,
+4061, 174, 811, 29, 235, 1840, 7052, 3596, 6147, 6039, 3699,
+4062, 358, 1042, 1041, 469, 7400, 2532, 7399, 4407, 6029, 6015,
+4063, 987, 410, 264, 830, 5921, 4227, 7185, 2370, 5922, 6935,
+4064, 1233, 557, 1144, 602, 6632, 7403, 3237, 7404, 4860, 7401,
+4065, 239, 1072, 900, 818, 7405, 2640, 5567, 7342, 2639, 2219,
+4066, 42, 865, 187, 864, 5781, 1964, 7209, 5792, 1966, 1962,
+4067, 940, 563, 382, 941, 5645, 4716, 7406, 2236, 7407, 7098,
+4068, 382, 940, 331, 478, 7406, 5772, 4144, 4438, 5773, 4435,
+4069, 1299, 740, 1277, 674, 7409, 7408, 3397, 7410, 5220, 5561,
+4070, 468, 1040, 1041, 321, 7411, 2529, 6881, 4405, 7412, 7351,
+4071, 331, 940, 382, 941, 5772, 7406, 4144, 7099, 2236, 7098,
+4072, 407, 406, 1057, 515, 4219, 6395, 7413, 4570, 4569, 7414,
+4073, 1144, 557, 1233, 1143, 7403, 6632, 3237, 2883, 6886, 3236,
+4074, 479, 496, 1083, 951, 4512, 6339, 7415, 7295, 7296, 2690,
+4075, 953, 798, 336, 797, 2271, 7000, 6998, 2270, 1802, 7065,
+4076, 952, 1083, 372, 1084, 2691, 7416, 6740, 2693, 2695, 7417,
+4077, 843, 1063, 925, 431, 2607, 2609, 2178, 7071, 5912, 5875,
+4078, 479, 951, 1083, 952, 7295, 2690, 7415, 7335, 2269, 2691,
+4079, 335, 794, 371, 795, 5961, 7247, 4121, 6232, 1793, 6286,
+4080, 692, 1251, 691, 622, 7419, 7418, 5289, 5162, 7420, 5161,
+4081, 559, 1200, 1139, 550, 6866, 3080, 6929, 4702, 7136, 7421,
+4082, 881, 59, 204, 882, 7422, 7251, 2013, 2017, 6928, 2015,
+4083, 407, 986, 408, 1105, 6947, 6948, 4222, 7423, 2760, 6706,
+4084, 479, 795, 371, 950, 6285, 6286, 4466, 7294, 2262, 6890,
+4085, 1373, 912, 830, 262, 6376, 2199, 6374, 7424, 7425, 5913,
+4086, 518, 987, 1101, 517, 5827, 2750, 5826, 4581, 5592, 5591,
+4087, 694, 695, 724, 1311, 5266, 5360, 5264, 5985, 5687, 5686,
+4088, 1363, 1370, 778, 1372, 1605, 6993, 7426, 1630, 1626, 6994,
+4089, 1185, 520, 1109, 519, 6361, 6362, 3025, 7427, 4587, 6524,
+4090, 67, 68, 890, 360, 1591, 7428, 7243, 4033, 4032, 7246,
+4091, 473, 554, 1151, 1150, 4688, 7429, 7110, 7111, 7430, 2904,
+4092, 472, 1047, 1148, 1149, 7432, 2894, 7431, 7433, 2896, 2898,
+4093, 570, 610, 1209, 1208, 4890, 5618, 7434, 7435, 5619, 3117,
+4094, 1373, 204, 882, 205, 7250, 2015, 6731, 6375, 1441, 2016,
+4095, 549, 1083, 1177, 1084, 6337, 3001, 7436, 7437, 2695, 3002,
+4096, 1149, 1048, 472, 1047, 2897, 6675, 7433, 2896, 2550, 7432,
+4097, 1116, 1059, 401, 512, 2798, 5993, 7438, 6459, 7439, 4558,
+4098, 479, 952, 1083, 372, 7335, 2691, 7415, 4499, 6740, 7416,
+4099, 377, 808, 484, 234, 6777, 7141, 4455, 4133, 6324, 4454,
+4100, 1020, 864, 865, 347, 2464, 1966, 2465, 6087, 5793, 5791,
+4101, 964, 1093, 493, 1094, 2726, 7031, 7030, 2729, 2731, 7303,
+4102, 549, 581, 1177, 651, 4797, 5510, 7436, 5019, 5021, 7440,
+4103, 1116, 1059, 512, 983, 2798, 7439, 6459, 2797, 2646, 7315,
+4104, 1175, 1205, 603, 558, 3189, 7441, 6219, 7442, 7443, 4864,
+4105, 512, 1059, 402, 983, 7439, 7231, 4559, 7315, 2646, 7232,
+4106, 1116, 1113, 401, 1059, 2944, 7444, 7438, 2798, 2787, 5993,
+4107, 416, 1103, 523, 522, 7115, 6601, 4595, 4593, 6157, 4597,
+4108, 402, 1059, 512, 401, 7231, 7439, 4559, 4204, 5993, 4558,
+4109, 982, 401, 1113, 1059, 5992, 7444, 2788, 2591, 5993, 2787,
+4110, 41, 820, 903, 244, 5753, 2158, 5752, 3725, 6529, 6213,
+4111, 881, 882, 356, 59, 2017, 7298, 7297, 7422, 6928, 4025,
+4112, 259, 258, 910, 985, 3772, 6373, 6348, 6111, 7445, 2363,
+4113, 263, 61, 206, 60, 3783, 6680, 5690, 3782, 1584, 5689,
+4114, 67, 211, 889, 212, 7446, 2036, 7237, 6801, 1448, 2037,
+4115, 605, 602, 1233, 1307, 4872, 7404, 6631, 6770, 7447, 3505,
+4116, 990, 414, 415, 268, 6019, 4243, 5517, 6831, 4239, 4241,
+4117, 887, 888, 359, 65, 2035, 5820, 7448, 7449, 7450, 4031,
+4118, 1021, 311, 1020, 865, 7093, 6088, 2469, 2467, 7292, 2465,
+4119, 373, 565, 481, 1086, 4722, 4721, 4461, 7201, 6378, 5625,
+4120, 318, 355, 1035, 465, 4065, 5503, 7451, 4396, 4399, 7452,
+4121, 392, 973, 1056, 391, 7453, 2577, 7384, 4174, 7391, 7383,
+4122, 735, 719, 1295, 697, 5402, 7455, 7454, 5398, 5242, 7456,
+4123, 759, 1336, 735, 719, 7143, 7457, 5456, 5392, 7144, 5402,
+4124, 822, 978, 246, 904, 2346, 7459, 7458, 2191, 2441, 7460,
+4125, 812, 235, 967, 811, 7300, 6038, 2313, 1844, 6039, 2312,
+4126, 616, 610, 570, 1208, 4909, 4890, 4907, 5553, 5619, 7435,
+4127, 978, 822, 246, 247, 2346, 7458, 7459, 7461, 6659, 3736,
+4128, 295, 93, 930, 848, 3878, 7463, 7462, 7464, 7465, 2183,
+4129, 731, 1287, 1304, 1337, 6930, 3267, 6924, 7466, 2653, 2982,
+4130, 1102, 510, 400, 399, 5659, 4553, 5737, 6997, 4552, 4198,
+4131, 537, 634, 1112, 635, 4959, 7468, 7467, 4961, 4963, 5926,
+4132, 733, 774, 737, 1349, 5449, 5448, 5385, 7469, 7471, 7470,
+4133, 1223, 1174, 513, 1104, 3191, 7472, 5543, 3187, 2992, 5544,
+4134, 1002, 844, 432, 433, 2413, 7473, 5837, 5816, 7474, 4298,
+4135, 984, 404, 403, 513, 5499, 4210, 6476, 7475, 4563, 4562,
+4136, 510, 1113, 511, 1181, 5660, 5514, 4557, 6400, 3014, 5515,
+4137, 540, 1166, 638, 637, 5704, 5863, 4970, 4968, 5878, 4972,
+4138, 1065, 536, 1155, 634, 7476, 6354, 2918, 7477, 4958, 7478,
+4139, 1155, 634, 1112, 1065, 7478, 7468, 2920, 2918, 7477, 2783,
+4140, 612, 669, 1214, 583, 5087, 6050, 7019, 5003, 5085, 6218,
+4141, 444, 445, 933, 300, 4334, 7172, 5766, 4330, 4332, 7479,
+4142, 1242, 1181, 624, 590, 3285, 5576, 7480, 7481, 5577, 5058,
+4143, 1172, 641, 1237, 642, 7181, 5571, 3324, 6254, 4985, 5572,
+4144, 623, 510, 624, 1181, 4926, 4928, 4930, 6846, 6400, 5576,
+4145, 590, 511, 512, 1116, 4821, 4560, 4822, 6281, 5513, 6459,
+4146, 231, 802, 374, 338, 7336, 6645, 4128, 4051, 7105, 4127,
+4147, 534, 995, 1098, 533, 7482, 2745, 6502, 4630, 7483, 6903,
+4148, 1098, 995, 998, 533, 2745, 2606, 2743, 6903, 7483, 7484,
+4149, 430, 431, 534, 995, 4292, 4629, 4628, 7485, 7486, 7482,
+4150, 430, 995, 924, 843, 7485, 2392, 5884, 5881, 2391, 2207,
+4151, 430, 995, 534, 533, 7485, 7482, 4628, 4626, 7483, 4630,
+4152, 404, 405, 985, 258, 4213, 6109, 5497, 4209, 4211, 7445,
+4153, 886, 1041, 321, 358, 2528, 7351, 7350, 6187, 7399, 4068,
+4154, 469, 468, 1041, 321, 4409, 6881, 6015, 4408, 4405, 7351,
+4155, 357, 885, 1040, 321, 7282, 2525, 7395, 4091, 7289, 7412,
+4156, 775, 1368, 1359, 1358, 6267, 1658, 6299, 6268, 1656, 1659,
+4157, 998, 995, 430, 533, 2606, 7485, 7487, 7484, 7483, 4626,
+4158, 615, 1217, 595, 596, 5526, 6749, 5138, 5033, 5528, 4841,
+4159, 1245, 515, 1105, 1187, 7489, 7488, 3296, 3297, 7490, 3032,
+4160, 595, 1217, 1218, 596, 6749, 3162, 6495, 4841, 5528, 6496,
+4161, 440, 849, 441, 1006, 6907, 6908, 4322, 7491, 2425, 6224,
+4162, 1339, 699, 701, 751, 6542, 5244, 6911, 6913, 5358, 5357,
+4163, 881, 59, 356, 319, 7422, 4025, 7297, 5595, 3938, 4066,
+4164, 964, 377, 963, 808, 7032, 7140, 2305, 2303, 6777, 2301,
+4165, 353, 1032, 317, 877, 7214, 7328, 4087, 7492, 2501, 7493,
+4166, 1141, 556, 1142, 1201, 6726, 7494, 2877, 3234, 6534, 3084,
+4167, 1332, 737, 682, 715, 7183, 5319, 5869, 5868, 5318, 5285,
+4168, 639, 708, 1186, 709, 5210, 6070, 6517, 5211, 5213, 6151,
+4169, 1297, 689, 1253, 1289, 6595, 7123, 3467, 3192, 7365, 3457,
+4170, 56, 57, 828, 202, 1580, 6328, 6330, 7495, 6242, 1881,
+4171, 967, 378, 584, 1095, 7022, 4802, 5647, 2735, 6295, 5649,
+4172, 462, 555, 463, 1132, 4691, 4690, 4478, 7496, 5973, 5795,
+4173, 660, 579, 606, 1199, 5064, 4875, 5065, 6865, 6747, 6864,
+4174, 965, 378, 966, 1095, 6294, 7023, 2311, 2732, 6295, 2733,
+4175, 1166, 1004, 540, 1003, 2955, 6951, 5704, 2954, 2420, 5706,
+4176, 692, 1251, 749, 691, 7419, 7497, 5349, 5289, 7418, 5348,
+4177, 153, 13, 154, 791, 3558, 3560, 1389, 1779, 5692, 1780,
+4178, 315, 1028, 461, 488, 5998, 6566, 4388, 4474, 5999, 4475,
+4179, 934, 853, 447, 1070, 2215, 5725, 7272, 2633, 2632, 5726,
+4180, 1006, 1003, 440, 849, 2579, 7498, 7491, 2425, 2580, 6907,
+4181, 791, 13, 154, 227, 5692, 3560, 1780, 6101, 3683, 7499,
+4182, 1030, 874, 352, 1029, 2494, 7270, 5805, 2496, 2492, 7500,
+4183, 525, 420, 526, 1108, 4604, 4605, 4607, 7358, 6915, 5719,
+4184, 1131, 488, 462, 579, 7501, 4476, 5782, 6748, 4785, 4784,
+4185, 461, 1129, 492, 488, 6619, 7502, 4503, 4475, 7503, 4505,
+4186, 315, 488, 462, 1029, 4474, 4476, 4390, 5996, 5997, 5784,
+4187, 253, 399, 252, 981, 4194, 4193, 3754, 5758, 5759, 6721,
+4188, 891, 360, 1046, 890, 6642, 6643, 2543, 2044, 7246, 2542,
+4189, 1046, 360, 1045, 890, 6643, 7504, 2544, 2542, 7246, 2540,
+4190, 559, 1296, 648, 1201, 6867, 7505, 5007, 6021, 3464, 6533,
+4191, 309, 861, 1017, 862, 6145, 2455, 7212, 6159, 1957, 2456,
+4192, 562, 565, 649, 1087, 4723, 5012, 5011, 6131, 6379, 7506,
+4193, 516, 1245, 1101, 591, 7507, 3295, 6816, 4825, 7508, 6513,
+4194, 1312, 1334, 743, 1300, 3378, 6974, 7509, 3379, 3124, 6815,
+4195, 309, 346, 39, 862, 4056, 4005, 3918, 6159, 7510, 6158,
+4196, 461, 1028, 1129, 488, 6566, 2837, 6619, 4475, 5999, 7503,
+4197, 925, 1063, 1064, 432, 2609, 2613, 2612, 5876, 5911, 5839,
+4198, 1106, 1104, 513, 984, 2926, 5544, 5542, 2764, 2757, 7475,
+4199, 1298, 645, 659, 1285, 6724, 5062, 6788, 3469, 5539, 7511,
+4200, 53, 198, 197, 875, 6451, 1434, 6449, 7512, 1995, 1994,
+4201, 822, 247, 44, 246, 6659, 3734, 7513, 7458, 3736, 3732,
+4202, 826, 255, 198, 197, 6982, 6452, 1877, 1878, 6450, 1434,
+4203, 184, 38, 39, 861, 5924, 1562, 7514, 1953, 6146, 6144,
+4204, 2, 5, 143, 1374, 1497, 3542, 3539, 6604, 7515, 6603,
+4205, 154, 14, 227, 13, 3562, 3682, 7499, 3560, 1506, 3683,
+4206, 447, 446, 934, 1070, 4340, 7226, 7272, 5726, 6872, 2633,
+4207, 974, 388, 1100, 500, 5678, 7516, 2748, 6024, 4521, 7517,
+4208, 980, 1107, 397, 979, 2766, 6511, 6509, 2584, 2767, 6544,
+4209, 309, 344, 1016, 861, 4003, 5835, 7518, 6145, 6531, 2453,
+4210, 241, 388, 976, 974, 4160, 7519, 6077, 6201, 5678, 2339,
+4211, 495, 499, 601, 1183, 4764, 4857, 4856, 7520, 5683, 5681,
+4212, 593, 1258, 671, 1260, 7521, 6269, 5092, 7522, 3387, 5562,
+4213, 625, 1174, 1242, 590, 7524, 3284, 7523, 4933, 6457, 7481,
+4214, 345, 1014, 858, 1005, 7194, 2447, 6575, 6576, 2643, 2567,
+4215, 1094, 596, 615, 493, 5527, 5033, 5525, 7303, 4906, 4902,
+4216, 1033, 354, 317, 878, 7525, 4064, 7327, 2504, 7527, 7526,
+4217, 1129, 1028, 461, 1027, 2837, 6566, 6619, 2836, 2490, 6568,
+4218, 879, 354, 1034, 878, 7529, 7528, 2507, 2008, 7527, 2506,
+4219, 759, 718, 1325, 719, 5393, 6735, 7142, 5392, 5241, 6736,
+4220, 307, 365, 345, 1005, 4106, 4109, 4104, 5520, 5899, 6576,
+4221, 1167, 1069, 546, 1169, 2957, 5735, 5733, 3020, 2966, 6300,
+4222, 350, 1025, 459, 1026, 7531, 7530, 4378, 7202, 2484, 7532,
+4223, 612, 1214, 1282, 1215, 7019, 3424, 7020, 6842, 3148, 3425,
+4224, 1090, 494, 583, 1089, 5530, 4800, 6216, 2716, 7229, 6217,
+4225, 400, 1113, 511, 510, 5739, 5514, 4555, 4553, 5660, 4557,
+4226, 1195, 1225, 646, 644, 3356, 6627, 7533, 7055, 6083, 5022,
+4227, 1107, 1102, 509, 1179, 2927, 6989, 6971, 3027, 3007, 7534,
+4228, 351, 1027, 1028, 872, 6567, 2490, 6565, 6590, 2486, 2488,
+4229, 459, 1127, 381, 1026, 7320, 7264, 4381, 7532, 2831, 7200,
+4230, 351, 314, 461, 1027, 4061, 4386, 4385, 6567, 6980, 6568,
+4231, 381, 1027, 461, 314, 7199, 6568, 4387, 4141, 6980, 4386,
+4232, 605, 557, 1233, 602, 4870, 6632, 6631, 4872, 4860, 7404,
+4233, 606, 687, 1286, 619, 5143, 6069, 6067, 4916, 5144, 6946,
+4234, 1086, 956, 562, 481, 2703, 6917, 6377, 5625, 5623, 4712,
+4235, 546, 1069, 1070, 1169, 5735, 2652, 6871, 6300, 2966, 2965,
+4236, 1107, 1193, 622, 621, 3051, 7346, 6018, 7535, 6092, 4924,
+4237, 1198, 1228, 1286, 619, 3219, 3498, 3436, 6704, 6679, 6946,
+4238, 812, 235, 174, 30, 7300, 6147, 1842, 7536, 3698, 3598,
+4239, 1195, 632, 613, 644, 6182, 4954, 7537, 7055, 5048, 4993,
+4240, 858, 345, 307, 35, 6575, 4104, 5519, 6179, 4002, 3914,
+4241, 1082, 496, 549, 651, 6338, 4725, 6336, 7538, 5020, 5019,
+4242, 1035, 1036, 1137, 487, 2514, 2861, 2860, 5505, 5506, 7299,
+4243, 383, 944, 1077, 368, 5701, 2669, 7191, 4149, 5745, 5743,
+4244, 613, 644, 1189, 1195, 4993, 6548, 6547, 7537, 7055, 3058,
+4245, 385, 343, 1012, 1011, 4357, 7540, 7539, 7541, 7102, 2439,
+4246, 553, 1136, 465, 464, 7386, 7542, 4685, 4686, 7543, 4398,
+4247, 1138, 1037, 1139, 466, 2864, 2866, 2868, 6413, 7236, 7544,
+4248, 583, 494, 649, 1089, 4800, 5014, 5025, 6217, 7229, 6136,
+4249, 490, 467, 1140, 1038, 4485, 7545, 6128, 7546, 7547, 2869,
+4250, 682, 1341, 659, 733, 6787, 6789, 5127, 5303, 7548, 5301,
+4251, 357, 883, 1039, 884, 6653, 2521, 7549, 6652, 2023, 2522,
+4252, 881, 319, 356, 1037, 5595, 4066, 7297, 2515, 7234, 7235,
+4253, 724, 701, 1308, 695, 5333, 6274, 5684, 5360, 5261, 5685,
+4254, 374, 802, 231, 957, 6645, 7336, 4128, 6646, 2283, 7241,
+4255, 345, 35, 858, 36, 4002, 6179, 6575, 4001, 1559, 7550,
+4256, 947, 791, 792, 227, 2252, 1784, 2253, 6100, 6101, 6790,
+4257, 496, 950, 479, 371, 6891, 7294, 4512, 4513, 6890, 4466,
+4258, 362, 1049, 1050, 894, 7551, 2556, 6692, 6690, 2552, 2554,
+4259, 342, 812, 175, 30, 6722, 1843, 6207, 3990, 7536, 3597,
+4260, 473, 1049, 1151, 1050, 6608, 2902, 7110, 7266, 2556, 2903,
+4261, 587, 609, 1184, 1269, 4918, 6661, 6089, 6036, 6885, 3381,
+4262, 1020, 347, 384, 1019, 6087, 4150, 5951, 2466, 7552, 5950,
+4263, 1210, 598, 1079, 1080, 6388, 6389, 3118, 3119, 6900, 2680,
+4264, 1216, 1093, 572, 1092, 3153, 7554, 7553, 3152, 2725, 7555,
+4265, 231, 800, 21, 337, 5871, 7204, 3691, 4078, 5966, 3979,
+4266, 270, 1061, 416, 269, 7133, 7116, 4245, 3805, 7556, 4244,
+4267, 385, 238, 1012, 343, 4152, 6226, 7539, 4357, 4110, 7540,
+4268, 990, 269, 415, 1061, 7239, 4242, 5517, 2600, 7556, 5518,
+4269, 535, 1157, 633, 632, 5655, 6799, 4955, 4953, 6183, 4957,
+4270, 560, 554, 472, 1149, 4706, 4689, 4704, 6042, 7557, 7433,
+4271, 415, 269, 416, 1061, 4242, 4244, 4246, 5518, 7556, 7116,
+4272, 1374, 222, 4, 816, 7558, 1459, 6602, 7559, 1856, 1855,
+4273, 762, 1291, 759, 718, 6445, 6444, 5413, 5404, 7560, 5393,
+4274, 925, 117, 288, 844, 2125, 7562, 7561, 2208, 1916, 7563,
+4275, 490, 1039, 1141, 1040, 7564, 2872, 6127, 7565, 2526, 2873,
+4276, 697, 1280, 653, 676, 6356, 6355, 5174, 5175, 6351, 5105,
+4277, 308, 1014, 456, 1015, 7566, 6116, 4367, 6558, 2451, 6117,
+4278, 999, 456, 1154, 426, 7193, 5790, 2914, 7290, 4714, 7169,
+4279, 858, 181, 859, 36, 1944, 1946, 1948, 7550, 7568, 7567,
+4280, 451, 1018, 1019, 310, 7569, 2463, 7265, 4350, 7256, 5641,
+4281, 572, 1215, 1216, 1092, 7570, 3154, 7553, 7555, 3149, 3152,
+4282, 1316, 686, 1283, 1259, 6344, 7571, 3114, 3537, 6289, 3534,
+4283, 47, 193, 870, 48, 7260, 1980, 6781, 1571, 6585, 6995,
+4284, 831, 62, 1377, 265, 7574, 7573, 7572, 7575, 3788, 6710,
+4285, 686, 664, 1316, 1283, 5150, 7576, 6344, 7571, 7577, 3114,
+4286, 1231, 487, 1136, 1137, 7579, 7578, 3078, 3226, 7299, 2862,
+4287, 825, 907, 252, 50, 2194, 6761, 6720, 7580, 7331, 3750,
+4288, 1284, 686, 1283, 664, 6570, 7571, 3525, 6571, 5150, 7577,
+4289, 1150, 1049, 472, 1048, 2900, 6609, 7581, 2899, 2553, 6675,
+4290, 892, 70, 215, 893, 7037, 7068, 2046, 2050, 7039, 2048,
+4291, 548, 1010, 1158, 1183, 5807, 2930, 6572, 6802, 3022, 3021,
+4292, 836, 919, 218, 73, 2174, 2111, 1897, 7197, 6028, 6097,
+4293, 1220, 1237, 1164, 641, 3255, 3254, 3167, 6369, 5571, 6261,
+4294, 1269, 1250, 679, 663, 3414, 6854, 6852, 6857, 6855, 5122,
+4295, 385, 1011, 1012, 1072, 7541, 2439, 7539, 7582, 2800, 2641,
+4296, 1008, 1172, 1167, 545, 2970, 2969, 2958, 7583, 6253, 6252,
+4297, 451, 1120, 384, 1019, 5942, 7584, 4353, 7265, 2810, 5950,
+4298, 1184, 609, 501, 500, 6661, 4917, 6660, 6843, 4887, 4526,
+4299, 587, 1269, 672, 663, 6036, 7585, 5093, 5170, 6857, 5171,
+4300, 546, 1070, 547, 1169, 6871, 5731, 4672, 6300, 2965, 6257,
+4301, 548, 1183, 1165, 1009, 6802, 3034, 6193, 5664, 3033, 2951,
+4302, 1012, 1072, 900, 238, 2641, 2640, 2446, 6226, 7586, 5568,
+4303, 1232, 1296, 559, 1201, 3488, 6867, 6006, 3235, 3464, 6021,
+4304, 1254, 620, 1188, 587, 6850, 7587, 3332, 6035, 4812, 6034,
+4305, 648, 1201, 1296, 1267, 6533, 3464, 7505, 6489, 3463, 3465,
+4306, 1318, 1338, 1294, 765, 1726, 3213, 3214, 7588, 7589, 6321,
+4307, 535, 432, 1064, 1063, 4632, 5839, 5653, 5910, 5911, 2613,
+4308, 385, 1072, 1012, 238, 7582, 2641, 7539, 4152, 7586, 6226,
+4309, 1023, 312, 868, 349, 5698, 7590, 2474, 5507, 4059, 5509,
+4310, 1158, 386, 387, 997, 7592, 4159, 7591, 2931, 7044, 7593,
+4311, 539, 636, 538, 1171, 4965, 4964, 4647, 7594, 6762, 6312,
+4312, 894, 71, 325, 893, 5676, 3950, 6851, 2053, 5675, 7595,
+4313, 495, 450, 385, 1158, 4510, 4462, 4511, 6573, 6574, 7596,
+4314, 749, 1251, 1297, 741, 7497, 3466, 7597, 5351, 7598, 6596,
+4315, 691, 689, 1253, 741, 5259, 7123, 7599, 5350, 5327, 7600,
+4316, 1012, 343, 238, 237, 7540, 4110, 6226, 6227, 3994, 3709,
+4317, 1068, 442, 441, 543, 7061, 4325, 6222, 6514, 4658, 4657,
+4318, 1123, 498, 1122, 455, 6403, 7601, 2820, 5748, 4517, 6662,
+4319, 386, 1072, 997, 1158, 7602, 2642, 7044, 7592, 2928, 2931,
+4320, 1176, 1080, 580, 598, 2999, 7604, 7603, 6899, 6900, 4862,
+4321, 1230, 1285, 647, 1261, 3434, 5538, 6560, 3350, 3435, 5540,
+4322, 1256, 1254, 688, 1289, 3447, 7375, 7605, 3449, 3451, 7377,
+4323, 335, 795, 479, 796, 6232, 6285, 4443, 7606, 1796, 7607,
+4324, 228, 949, 793, 476, 6894, 2258, 6409, 4426, 5769, 6387,
+4325, 1094, 493, 615, 1093, 7303, 4902, 5525, 2731, 7031, 7608,
+4326, 738, 767, 736, 1371, 5426, 5425, 5323, 6526, 6527, 6667,
+4327, 1092, 1091, 961, 376, 2722, 2718, 2720, 7609, 7610, 5602,
+4328, 679, 710, 1240, 1256, 5356, 6288, 7309, 6853, 7277, 3349,
+4329, 736, 759, 1360, 770, 5446, 5980, 5978, 5464, 5463, 6366,
+4330, 615, 1216, 1217, 1093, 7611, 3156, 5526, 7608, 3153, 3157,
+4331, 1269, 672, 679, 1256, 7585, 5252, 6852, 3444, 7612, 6853,
+4332, 963, 377, 340, 808, 7140, 4134, 7613, 2301, 6777, 6776,
+4333, 744, 772, 742, 1356, 5466, 5465, 5336, 7614, 6958, 6957,
+4334, 918, 273, 420, 274, 7339, 4256, 7056, 6670, 3817, 4257,
+4335, 562, 1087, 649, 1088, 6131, 7506, 5011, 6130, 2710, 6137,
+4336, 1052, 1115, 1153, 475, 2974, 2983, 2909, 5941, 7616, 7615,
+4337, 1365, 1359, 777, 768, 1657, 6493, 6491, 6265, 6263, 5492,
+4338, 473, 1151, 1152, 1050, 7110, 2907, 7219, 7266, 2903, 2905,
+4339, 1242, 590, 694, 625, 7481, 5168, 6104, 7523, 4933, 5169,
+4340, 894, 893, 325, 1049, 2053, 7595, 6851, 2552, 2551, 6610,
+4341, 419, 525, 418, 992, 4602, 4601, 4255, 7617, 7359, 5920,
+4342, 417, 523, 416, 1103, 4596, 4595, 4249, 6600, 6601, 7115,
+4343, 1376, 216, 893, 71, 7070, 2049, 7076, 7025, 5674, 5675,
+4344, 625, 1223, 1241, 1174, 7619, 3280, 7618, 7524, 3191, 3281,
+4345, 396, 979, 507, 506, 6543, 7620, 4543, 4541, 6919, 4545,
+4346, 417, 416, 991, 1103, 4249, 7114, 7621, 6600, 7115, 2755,
+4347, 515, 1245, 1105, 516, 7489, 3296, 7488, 4574, 7507, 6817,
+4348, 507, 396, 397, 979, 4543, 4189, 4544, 7620, 6543, 6544,
+4349, 492, 1228, 606, 488, 6677, 6678, 4874, 4505, 6693, 4873,
+4350, 991, 271, 834, 916, 7217, 6210, 2380, 2381, 7218, 2203,
+4351, 207, 831, 208, 62, 1888, 1887, 1444, 7622, 7574, 7623,
+4352, 1354, 756, 1343, 1357, 6282, 6970, 1673, 1654, 6283, 1672,
+4353, 887, 1043, 359, 888, 2533, 7624, 7448, 2035, 2534, 5820,
+4354, 407, 1105, 516, 515, 7423, 6817, 4572, 4570, 7488, 4574,
+4355, 186, 41, 187, 864, 5751, 7625, 1423, 1961, 7130, 1962,
+4356, 1362, 764, 733, 1349, 6108, 5412, 6106, 1624, 6447, 7469,
+4357, 1187, 1105, 1057, 515, 3032, 2761, 3030, 7490, 7488, 7414,
+4358, 1057, 1105, 407, 515, 2761, 7423, 7413, 7414, 7488, 4570,
+4359, 1104, 984, 403, 513, 2757, 6476, 6477, 5544, 7475, 4562,
+4360, 401, 400, 254, 982, 4201, 4197, 4199, 5992, 5738, 6879,
+4361, 503, 391, 1056, 1114, 4530, 7383, 7382, 5861, 5862, 2791,
+4362, 1308, 1322, 724, 1311, 3227, 7626, 5684, 3524, 3209, 5686,
+4363, 502, 1114, 501, 390, 5860, 7627, 4529, 4527, 7628, 4525,
+4364, 385, 238, 239, 1072, 4152, 3712, 4153, 7582, 7586, 7405,
+4365, 501, 1114, 1163, 390, 7627, 2946, 6032, 4525, 7628, 6033,
+4366, 749, 1300, 1297, 1251, 7629, 3427, 7597, 7497, 3479, 3466,
+4367, 742, 1356, 1364, 1358, 6957, 1634, 6484, 6467, 1671, 1655,
+4368, 459, 381, 350, 1026, 4381, 4142, 4378, 7532, 7200, 7202,
+4369, 1226, 1225, 617, 1257, 3256, 6628, 6808, 2986, 3355, 6629,
+4370, 567, 1127, 1227, 566, 7321, 3212, 5608, 4733, 7630, 6708,
+4371, 567, 566, 459, 1127, 4733, 4729, 4731, 7321, 7630, 7320,
+4372, 502, 1114, 1188, 501, 5860, 3035, 6074, 4529, 7627, 7631,
+4373, 261, 986, 407, 260, 6949, 6947, 4218, 3778, 6807, 4217,
+4374, 351, 49, 871, 194, 4015, 6622, 6589, 7632, 7325, 1983,
+4375, 557, 556, 1142, 468, 4789, 7494, 6883, 4695, 4692, 6880,
+4376, 1139, 466, 550, 1138, 7544, 4680, 7421, 2868, 6413, 6411,
+4377, 1138, 487, 550, 1137, 6412, 4783, 6411, 2865, 7299, 7135,
+4378, 1353, 721, 738, 725, 6553, 5321, 6615, 7633, 5283, 5322,
+4379, 869, 1025, 1024, 313, 2479, 2481, 2477, 7634, 7636, 7635,
+4380, 1232, 1140, 559, 1139, 3082, 6007, 6006, 3081, 2871, 6929,
+4381, 1134, 564, 489, 552, 7637, 4717, 5958, 6536, 4720, 4684,
+4382, 1188, 1114, 1163, 501, 3035, 2946, 3036, 7631, 7627, 6032,
+4383, 1128, 1127, 381, 566, 2835, 7264, 7263, 7638, 7630, 4728,
+4384, 661, 600, 645, 1261, 5067, 4995, 5068, 6725, 7639, 5541,
+4385, 890, 323, 1045, 889, 7244, 6177, 2540, 2041, 6181, 2539,
+4386, 353, 1031, 463, 1032, 5500, 5796, 4392, 7214, 2502, 5946,
+4387, 381, 1127, 459, 566, 7264, 7320, 4381, 4728, 7630, 4729,
+4388, 1334, 1319, 702, 760, 1712, 6005, 6003, 6973, 6464, 5395,
+4389, 1364, 1358, 775, 742, 1655, 6268, 6266, 6484, 6467, 5458,
+4390, 745, 765, 734, 1294, 5415, 5414, 5390, 7640, 6321, 6320,
+4391, 392, 904, 821, 246, 7642, 2159, 7641, 4173, 7460, 7643,
+4392, 478, 497, 1073, 367, 4780, 7645, 7644, 4437, 4726, 7646,
+4393, 538, 436, 1054, 435, 4642, 7347, 6311, 4641, 4307, 7175,
+4394, 714, 665, 1271, 652, 5224, 6697, 7240, 5223, 5077, 6698,
+4395, 731, 1337, 1304, 711, 7466, 2982, 6924, 5293, 7647, 6925,
+4396, 567, 1126, 370, 1125, 7318, 7648, 4732, 7649, 2829, 6738,
+4397, 1200, 1139, 550, 1138, 3080, 7421, 7136, 3079, 2868, 6411,
+4398, 1035, 355, 880, 1036, 5503, 6325, 2510, 2514, 5504, 2512,
+4399, 942, 786, 787, 225, 2237, 1769, 2238, 7113, 7090, 7081,
+4400, 1277, 740, 671, 674, 7408, 5221, 5560, 5561, 5220, 5147,
+4401, 880, 318, 1035, 879, 7650, 7451, 2510, 2011, 7651, 2509,
+4402, 894, 1049, 325, 362, 2552, 6610, 6851, 6690, 7551, 4072,
+4403, 1360, 1371, 767, 1369, 1645, 6527, 6367, 1646, 1631, 7652,
+4404, 1024, 1125, 370, 1126, 2825, 6738, 6739, 2827, 2829, 7648,
+4405, 1323, 1309, 723, 1316, 3412, 6391, 5673, 3476, 3477, 5671,
+4406, 1090, 494, 375, 571, 5530, 4743, 5529, 7313, 4795, 4748,
+4407, 77, 222, 1374, 816, 6162, 7558, 7653, 6120, 1856, 7559,
+4408, 1244, 592, 629, 1185, 7655, 4942, 7654, 3291, 7657, 7656,
+4409, 246, 904, 188, 189, 7460, 2081, 7658, 7659, 2080, 1425,
+4410, 658, 618, 576, 1234, 5061, 4913, 5059, 6674, 7660, 5600,
+4411, 593, 1260, 671, 629, 7522, 5562, 5092, 5030, 5590, 5091,
+4412, 1310, 1342, 1299, 699, 3151, 3142, 3155, 6540, 6541, 7661,
+4413, 361, 893, 892, 1048, 7038, 2050, 7011, 6868, 2549, 2548,
+4414, 1151, 1203, 1150, 554, 3092, 3091, 2904, 7429, 7662, 7430,
+4415, 404, 258, 985, 910, 4209, 7445, 5497, 5498, 6373, 2363,
+4416, 1351, 1338, 1318, 776, 1668, 1726, 1727, 7312, 7095, 7663,
+4417, 1365, 768, 777, 776, 6265, 5492, 6491, 7094, 5462, 5482,
+4418, 561, 1235, 560, 1148, 6826, 6044, 4710, 6727, 3243, 6043,
+4419, 978, 394, 1156, 1058, 7664, 6174, 2921, 2587, 7665, 3010,
+4420, 325, 893, 71, 70, 7595, 5675, 3950, 3951, 7039, 1594,
+4421, 625, 513, 626, 1223, 4932, 4823, 5042, 7619, 5543, 7666,
+4422, 472, 1149, 1148, 560, 7433, 2898, 7431, 4704, 6042, 6043,
+4423, 1150, 1203, 1149, 554, 3091, 3246, 2901, 7430, 7662, 7557,
+4424, 592, 1185, 628, 519, 7657, 6142, 5043, 4827, 7427, 4940,
+4425, 1243, 1182, 1260, 629, 3359, 3365, 3364, 6639, 7149, 5590,
+4426, 1287, 1271, 714, 665, 3438, 7240, 7667, 6931, 6697, 5224,
+4427, 11, 788, 151, 150, 7668, 1771, 3554, 3555, 1770, 1386,
+4428, 210, 887, 209, 64, 2031, 2030, 1446, 7669, 6192, 7670,
+4429, 367, 475, 1115, 454, 4518, 7616, 6753, 4364, 4463, 6756,
+4430, 487, 1231, 1136, 553, 7579, 3078, 7578, 4687, 7385, 7386,
+4431, 383, 226, 944, 368, 4146, 6221, 5701, 4149, 4116, 5745,
+4432, 230, 337, 20, 799, 4050, 3980, 3688, 6996, 5967, 6779,
+4433, 373, 799, 955, 337, 7671, 2276, 5914, 4125, 5967, 5965,
+4434, 771, 1348, 769, 1370, 7673, 7672, 5436, 7674, 1641, 6992,
+4435, 1019, 310, 1018, 863, 5641, 7256, 2463, 2461, 5643, 2459,
+4436, 451, 346, 1018, 310, 4351, 7254, 7569, 4350, 4105, 7256,
+4437, 1118, 1196, 574, 599, 3061, 7392, 7393, 7675, 7676, 4882,
+4438, 384, 310, 1019, 347, 4151, 5641, 5950, 4150, 4057, 7552,
+4439, 230, 799, 373, 337, 6996, 7671, 4126, 4050, 5967, 4125,
+4440, 987, 517, 518, 410, 5592, 4581, 5827, 5921, 4578, 4579,
+4441, 963, 808, 340, 807, 2301, 6776, 7613, 2300, 1832, 7677,
+4442, 29, 810, 341, 235, 7053, 7122, 3987, 3699, 7054, 4082,
+4443, 831, 207, 1377, 62, 1888, 7678, 7572, 7574, 7622, 7573,
+4444, 831, 913, 1377, 207, 2200, 6711, 7572, 1888, 2098, 7678,
+4445, 629, 1185, 520, 1182, 7656, 6361, 4943, 7149, 3172, 6363,
+4446, 1299, 674, 1244, 690, 7410, 7679, 3474, 7680, 5160, 7681,
+4447, 391, 1114, 502, 390, 5862, 5860, 4528, 4171, 7628, 4527,
+4448, 803, 802, 165, 338, 1817, 1813, 1815, 6280, 7105, 6279,
+4449, 487, 1136, 465, 553, 7578, 7542, 4472, 4687, 7386, 4685,
+4450, 815, 425, 814, 329, 6978, 5612, 1853, 6122, 4273, 5611,
+4451, 1021, 311, 866, 348, 7093, 7682, 2468, 7092, 4058, 5589,
+4452, 1306, 1293, 650, 1290, 3041, 6308, 7683, 3040, 3039, 7684,
+4453, 1376, 71, 893, 70, 7025, 5675, 7076, 7026, 1594, 7039,
+4454, 1255, 1192, 748, 1246, 3335, 6096, 7378, 3334, 3307, 7685,
+4455, 790, 13, 791, 333, 5693, 5692, 1781, 7686, 3971, 7687,
+4456, 1055, 414, 990, 832, 5857, 6019, 2575, 2573, 5859, 2378,
+4457, 1295, 1323, 735, 697, 1698, 5927, 7454, 7456, 5672, 5398,
+4458, 1100, 388, 976, 387, 7516, 7519, 2749, 7688, 4162, 6079,
+4459, 901, 976, 241, 240, 2338, 6077, 6148, 6834, 6078, 3718,
+4460, 656, 1247, 681, 720, 5786, 6241, 5125, 5245, 6234, 5246,
+4461, 502, 501, 1188, 587, 4529, 7631, 6074, 4809, 4808, 6034,
+4462, 1254, 620, 672, 688, 6850, 5094, 6849, 7375, 5152, 5151,
+4463, 243, 820, 902, 40, 6154, 2156, 7689, 3722, 5902, 7035,
+4464, 638, 1246, 639, 708, 5864, 6040, 4975, 5208, 6072, 5210,
+4465, 1253, 588, 1254, 688, 7125, 7690, 3333, 7376, 5178, 7375,
+4466, 1033, 1135, 1134, 464, 2854, 2856, 2852, 7691, 7692, 6535,
+4467, 843, 115, 85, 116, 1914, 3623, 7693, 1913, 1469, 3624,
+4468, 138, 102, 304, 103, 3663, 3905, 7694, 3664, 1552, 3906,
+4469, 353, 876, 1032, 877, 5502, 2500, 7214, 7492, 2002, 2501,
+4470, 1351, 739, 1327, 1344, 6441, 6442, 1729, 1703, 6845, 1728,
+4471, 303, 136, 137, 935, 7696, 1490, 7695, 7697, 2147, 2146,
+4472, 714, 731, 1287, 665, 5291, 6930, 7667, 5224, 5292, 6931,
+4473, 869, 349, 1024, 868, 7698, 5508, 2477, 1978, 5509, 2476,
+4474, 1175, 1205, 558, 1204, 3189, 7443, 7442, 3308, 3099, 7699,
+4475, 1346, 730, 703, 1335, 7701, 5391, 7700, 1715, 6563, 6664,
+4476, 1219, 523, 594, 630, 7702, 4832, 6347, 6402, 4945, 4947,
+4477, 1111, 521, 1243, 522, 6822, 6638, 3290, 6156, 4594, 6155,
+4478, 781, 223, 1013, 328, 6046, 5850, 2443, 6047, 4042, 5849,
+4479, 286, 843, 924, 115, 5882, 2207, 5883, 7703, 1914, 2123,
+4480, 781, 5, 1374, 143, 5603, 7515, 7704, 1750, 3542, 6603,
+4481, 286, 85, 287, 843, 3852, 3854, 3856, 5882, 7693, 6960,
+4482, 415, 414, 1111, 521, 4243, 6020, 5516, 4590, 4589, 6822,
+4483, 936, 854, 449, 304, 2189, 6618, 6617, 7705, 6126, 4344,
+4484, 936, 304, 449, 305, 7705, 4344, 6617, 7189, 3910, 4345,
+4485, 781, 77, 1374, 5, 6045, 7653, 7704, 5603, 3673, 7515,
+4486, 64, 266, 914, 267, 3792, 5582, 5581, 3794, 3796, 5548,
+4487, 503, 502, 1222, 620, 4532, 6073, 6169, 4811, 4810, 7706,
+4488, 1034, 1135, 1033, 464, 2855, 2854, 2508, 7707, 7692, 7691,
+4489, 1218, 1159, 528, 1095, 3185, 5708, 6922, 3161, 3163, 7085,
+4490, 465, 1136, 1034, 464, 7542, 2857, 7708, 4398, 7543, 7707,
+4491, 1339, 751, 1342, 699, 6913, 7302, 1665, 6542, 5358, 6541,
+4492, 505, 1239, 1156, 1180, 6313, 3302, 6172, 6093, 3276, 3016,
+4493, 847, 292, 123, 928, 7710, 7709, 1922, 2224, 7711, 2132,
+4494, 1120, 1018, 451, 1119, 2809, 7569, 5942, 2811, 2807, 5952,
+4495, 353, 877, 54, 876, 7492, 7712, 4018, 5502, 2002, 7713,
+4496, 54, 877, 199, 876, 7712, 2000, 6768, 7713, 2002, 1998,
+4497, 198, 876, 54, 199, 1997, 7713, 7714, 1435, 1998, 6768,
+4498, 270, 916, 991, 1061, 6196, 2381, 7132, 7133, 2601, 2648,
+4499, 353, 876, 54, 53, 5502, 7713, 4018, 4019, 7715, 1577,
+4500, 269, 1061, 833, 916, 7556, 2599, 6805, 6804, 2601, 2171,
+4501, 198, 199, 54, 256, 1435, 6768, 7714, 7716, 6407, 3762,
+4502, 472, 560, 1148, 491, 4704, 6043, 7431, 4492, 4705, 6728,
+4503, 210, 887, 65, 888, 2031, 7449, 6795, 2033, 2035, 7450,
+4504, 65, 887, 210, 64, 7449, 2031, 6795, 1588, 6192, 7669,
+4505, 622, 1193, 691, 621, 7346, 7717, 5161, 4924, 6092, 5158,
+4506, 1251, 1193, 691, 622, 3320, 7717, 7418, 7420, 7346, 5161,
+4507, 1102, 1179, 510, 509, 3007, 5658, 5659, 6989, 7534, 4554,
+4508, 1156, 394, 978, 393, 6174, 7664, 2921, 7718, 4180, 7719,
+4509, 1056, 504, 1156, 393, 6588, 6173, 2922, 7720, 4534, 7718,
+4510, 539, 1170, 637, 636, 7131, 5880, 4967, 4965, 6303, 4969,
+4511, 63, 886, 209, 208, 6185, 2028, 7721, 7722, 2027, 1445,
+4512, 1199, 1286, 660, 1285, 3483, 6068, 6865, 3468, 3484, 7723,
+4513, 846, 292, 436, 928, 7168, 4306, 7167, 2181, 7711, 7179,
+4514, 326, 1050, 474, 1051, 6691, 6598, 4423, 7262, 2559, 6418,
+4515, 327, 1052, 1053, 897, 5940, 2566, 5635, 7306, 2561, 2563,
+4516, 1055, 413, 1109, 520, 5858, 7724, 2772, 7725, 4586, 6362,
+4517, 155, 156, 793, 15, 1391, 1786, 1785, 3564, 3563, 6410,
+4518, 496, 1082, 951, 950, 6338, 2687, 7296, 6891, 2685, 2266,
+4519, 1291, 662, 1328, 1278, 7727, 7726, 2736, 3260, 7728, 3259,
+4520, 221, 898, 76, 899, 2064, 5846, 6859, 2066, 2068, 5847,
+4521, 220, 75, 221, 898, 7120, 7729, 1457, 2063, 5844, 2064,
+4522, 221, 75, 76, 898, 7729, 1599, 6859, 2064, 5844, 5846,
+4523, 1029, 488, 1130, 1028, 5997, 6695, 2840, 2493, 5999, 2839,
+4524, 908, 197, 255, 826, 2088, 6450, 7730, 2195, 1878, 6982,
+4525, 76, 75, 364, 898, 1599, 4041, 4040, 5846, 5844, 5842,
+4526, 1376, 70, 893, 215, 7026, 7039, 7076, 6963, 7068, 2048,
+4527, 691, 1193, 1253, 589, 7717, 3327, 7599, 5157, 7208, 7124,
+4528, 826, 401, 402, 255, 5991, 4204, 7248, 6982, 4200, 4202,
+4529, 682, 1341, 1332, 1298, 6787, 1732, 5869, 6786, 3090, 3159,
+4530, 909, 255, 826, 402, 6983, 6982, 2164, 7230, 4202, 7248,
+4531, 1253, 1193, 691, 1251, 3327, 7717, 7599, 3329, 3320, 7418,
+4532, 1307, 684, 1313, 1267, 7732, 7731, 1734, 1735, 7733, 1733,
+4533, 1149, 1203, 560, 554, 3246, 6803, 6042, 7557, 7662, 4706,
+4534, 1204, 1203, 1151, 554, 3095, 3092, 3093, 7734, 7662, 7429,
+4535, 628, 592, 1244, 1185, 5043, 7655, 6141, 6142, 7657, 3291,
+4536, 1092, 961, 483, 376, 2720, 7396, 7397, 7609, 5602, 4498,
+4537, 1147, 1146, 551, 1202, 2892, 7735, 6115, 3088, 3087, 7736,
+4538, 1320, 1275, 1276, 717, 3536, 3520, 3265, 6906, 5964, 5962,
+4539, 1361, 753, 1342, 1366, 7737, 6828, 1661, 1620, 6415, 1662,
+4540, 723, 664, 669, 1316, 5258, 5172, 5270, 5671, 7576, 7738,
+4541, 1109, 411, 1160, 519, 6523, 7739, 2936, 6524, 4582, 6134,
+4542, 605, 1267, 648, 684, 7091, 6489, 5009, 5131, 7733, 5132,
+4543, 472, 554, 1150, 1149, 4689, 7430, 7581, 7433, 7557, 2901,
+4544, 703, 1335, 1331, 1346, 6664, 1716, 6942, 7700, 1715, 1602,
+4545, 1211, 662, 651, 1278, 6200, 5070, 6199, 3409, 7728, 7740,
+4546, 685, 1290, 1272, 1306, 7741, 3452, 7249, 6204, 3040, 3506,
+4547, 1155, 1191, 633, 1157, 3045, 6798, 7742, 2996, 3046, 6799,
+4548, 1325, 718, 759, 1291, 6735, 5393, 7142, 3495, 7560, 6444,
+4549, 1363, 744, 778, 751, 7743, 5469, 7426, 7744, 5399, 5470,
+4550, 1043, 322, 470, 486, 7745, 4412, 6715, 6716, 4468, 4470,
+4551, 1281, 1214, 669, 653, 3423, 6050, 6049, 5829, 5830, 5086,
+4552, 650, 667, 1306, 685, 5082, 6392, 7683, 5135, 5137, 6204,
+4553, 929, 1003, 439, 1004, 2415, 6941, 7367, 2417, 2420, 6952,
+4554, 9, 8, 331, 148, 1501, 3967, 3966, 3551, 3549, 7394,
+4555, 1045, 1146, 1044, 471, 2888, 2887, 2541, 5629, 5630, 6176,
+4556, 441, 542, 440, 1006, 4655, 4654, 4322, 6224, 6225, 7491,
+4557, 550, 559, 1200, 614, 4702, 6866, 7136, 4900, 4899, 6469,
+4558, 1341, 1349, 1362, 733, 1692, 1624, 1691, 7548, 7469, 6106,
+4559, 426, 282, 427, 972, 4276, 4278, 4280, 7170, 7746, 6579,
+4560, 295, 94, 296, 930, 3879, 3881, 3883, 7462, 6961, 7747,
+4561, 385, 1072, 386, 1158, 7582, 7602, 4156, 7596, 2928, 7592,
+4562, 1006, 1003, 1099, 541, 2579, 2747, 2746, 7748, 5707, 6665,
+4563, 108, 921, 109, 79, 2115, 2117, 1462, 3610, 7749, 3611,
+4564, 649, 653, 583, 1213, 5035, 5037, 5025, 6138, 5831, 7750,
+4565, 914, 64, 209, 63, 5581, 7670, 2100, 5583, 1587, 7721,
+4566, 491, 1147, 561, 1148, 7751, 6114, 4707, 6728, 2895, 6727,
+4567, 657, 675, 614, 1302, 5103, 5102, 5057, 7752, 5988, 6774,
+4568, 543, 640, 542, 1168, 4977, 4976, 4659, 6515, 6520, 6516,
+4569, 297, 442, 931, 850, 4323, 7203, 5565, 5834, 6940, 2212,
+4570, 683, 1312, 702, 743, 7753, 6004, 5189, 5331, 7509, 5364,
+4571, 951, 795, 479, 950, 2264, 6285, 7295, 2266, 2262, 7294,
+4572, 653, 1214, 583, 1213, 5830, 6218, 5037, 5831, 3145, 7750,
+4573, 930, 296, 440, 849, 7747, 4318, 7754, 2211, 6909, 6907,
+4574, 846, 927, 1054, 435, 2131, 2569, 2568, 7348, 6456, 7175,
+4575, 97, 299, 298, 932, 3890, 3892, 3888, 7755, 5742, 5740,
+4576, 1281, 653, 1178, 1213, 5829, 6360, 3419, 3420, 5831, 3139,
+4577, 1021, 1122, 458, 455, 2816, 6301, 6302, 6663, 6662, 4377,
+4578, 902, 820, 243, 977, 2156, 6154, 7689, 2342, 2341, 6861,
+4579, 452, 1117, 569, 574, 5532, 6236, 4740, 4758, 6237, 4772,
+4580, 1243, 1260, 593, 629, 3364, 7522, 6637, 6639, 5590, 5030,
+4581, 1046, 1147, 491, 1148, 2891, 7751, 7756, 2893, 2895, 6728,
+4582, 495, 601, 548, 1183, 4856, 4858, 4746, 7520, 5681, 6802,
+4583, 1056, 1114, 1222, 503, 2791, 3184, 3183, 7382, 5861, 6169,
+4584, 109, 79, 281, 80, 3611, 3836, 7389, 3612, 1529, 3837,
+4585, 450, 1010, 1011, 1158, 6433, 2638, 7101, 6574, 2930, 2929,
+4586, 1227, 1126, 567, 1125, 3068, 7318, 5608, 3067, 2829, 7649,
+4587, 726, 763, 1340, 754, 5406, 5969, 5968, 5370, 5407, 7757,
+4588, 1046, 1147, 471, 491, 2891, 5631, 7758, 7756, 7751, 4490,
+4589, 340, 962, 483, 963, 7759, 7398, 4451, 7613, 2302, 7139,
+4590, 1045, 471, 1046, 1147, 5629, 7758, 2544, 2890, 5631, 2891,
+4591, 1243, 521, 1182, 629, 6638, 7148, 3359, 6639, 4944, 7149,
+4592, 1244, 690, 628, 1248, 7681, 5159, 6141, 3312, 7761, 7760,
+4593, 591, 1194, 628, 1248, 6607, 6143, 4941, 6975, 3310, 7760,
+4594, 195, 907, 825, 50, 2086, 2194, 1876, 6626, 7331, 7580,
+4595, 40, 310, 41, 863, 3921, 3920, 1564, 7268, 5643, 7238,
+4596, 628, 690, 591, 1248, 5159, 5156, 4941, 7760, 7761, 6975,
+4597, 835, 273, 419, 420, 7340, 4254, 7762, 7057, 4256, 4258,
+4598, 1153, 1205, 474, 497, 3097, 7764, 7763, 7765, 7766, 4515,
+4599, 603, 497, 558, 1205, 4863, 4699, 4864, 7441, 7766, 7443,
+4600, 1034, 354, 1033, 878, 7528, 7525, 2508, 2506, 7527, 2504,
+4601, 1035, 318, 1034, 879, 7451, 7767, 2511, 2509, 7651, 2507,
+4602, 202, 57, 58, 880, 6242, 1581, 6170, 2009, 6326, 5596,
+4603, 903, 973, 821, 245, 2331, 2330, 2155, 7768, 7770, 7769,
+4604, 688, 588, 1254, 620, 5178, 7690, 7375, 5152, 4920, 6850,
+4605, 986, 829, 262, 912, 2366, 7772, 7771, 2368, 2167, 7425,
+4606, 986, 408, 262, 261, 6948, 4221, 7771, 6949, 4220, 3781,
+4607, 462, 1132, 463, 1030, 7496, 5795, 4478, 5783, 2845, 5797,
+4608, 645, 552, 647, 1261, 4996, 5002, 5001, 5541, 7773, 5540,
+4609, 4, 1374, 143, 222, 6602, 6603, 1378, 1459, 7558, 1749,
+4610, 517, 516, 408, 1105, 4577, 4573, 4575, 6707, 6817, 6706,
+4611, 408, 516, 407, 1105, 4573, 4572, 4222, 6706, 6817, 7423,
+4612, 292, 90, 122, 291, 3869, 3635, 7355, 3871, 3867, 7356,
+4613, 122, 90, 121, 291, 3635, 3634, 1475, 7356, 3867, 7027,
+4614, 241, 387, 976, 388, 4158, 6079, 6077, 4160, 4162, 7519,
+4615, 239, 238, 900, 1072, 3712, 5568, 5567, 7405, 7586, 2640,
+4616, 386, 1072, 385, 239, 7602, 7582, 4156, 4154, 7405, 4153,
+4617, 626, 1223, 627, 680, 7666, 6244, 4937, 5120, 6255, 5164,
+4618, 83, 842, 284, 113, 7158, 6955, 3846, 3619, 1912, 7774,
+4619, 284, 842, 923, 113, 6955, 2222, 5765, 7774, 1912, 2121,
+4620, 900, 36, 818, 181, 5569, 7363, 2219, 2072, 7568, 1862,
+4621, 1217, 664, 1284, 1283, 6750, 6571, 3440, 3432, 7577, 3525,
+4622, 420, 993, 992, 835, 6916, 2598, 6914, 7057, 2386, 2384,
+4623, 1186, 1270, 1240, 709, 3382, 3384, 3278, 6151, 6249, 6153,
+4624, 1252, 1270, 1186, 709, 3383, 3382, 3325, 6248, 6249, 6151,
+4625, 219, 919, 837, 74, 2110, 2206, 1900, 7307, 6027, 7775,
+4626, 545, 444, 1067, 544, 4664, 7777, 7776, 4666, 4662, 7778,
+4627, 446, 301, 934, 852, 4335, 7215, 7226, 7779, 7223, 2187,
+4628, 1240, 1270, 710, 709, 3384, 6812, 6288, 6153, 6249, 5297,
+4629, 710, 1270, 734, 709, 6812, 6247, 5307, 5297, 6249, 5306,
+4630, 1021, 455, 458, 311, 6663, 4377, 6302, 7093, 4366, 4374,
+4631, 703, 1331, 1355, 1346, 6942, 1603, 7780, 7700, 1602, 1604,
+4632, 296, 95, 297, 128, 3882, 3884, 3886, 5574, 3646, 5573,
+4633, 583, 1214, 612, 1215, 6218, 7019, 5003, 6561, 3148, 6842,
+4634, 284, 82, 83, 113, 3845, 1532, 3846, 7774, 3618, 3619,
+4635, 901, 976, 240, 997, 2338, 6078, 6834, 2396, 2398, 6836,
+4636, 558, 497, 474, 1205, 4699, 4515, 4697, 7443, 7766, 7764,
+4637, 315, 50, 351, 873, 3931, 4014, 4085, 7781, 6625, 6623,
+4638, 392, 246, 821, 245, 4173, 7643, 7641, 4172, 3733, 7769,
+4639, 1196, 599, 578, 644, 7676, 4876, 6080, 6082, 4991, 4994,
+4640, 507, 1180, 506, 979, 7782, 6767, 4545, 7620, 3009, 6919,
+4641, 427, 841, 922, 283, 7783, 2223, 6578, 4279, 5713, 7784,
+4642, 540, 1004, 439, 1003, 6951, 6952, 4649, 5706, 2420, 6941,
+4643, 1293, 1203, 1263, 597, 3458, 3360, 3459, 6310, 7786, 7785,
+4644, 1274, 585, 616, 666, 5905, 5032, 5555, 5762, 5099, 5080,
+4645, 553, 1135, 464, 552, 7387, 7692, 4686, 4788, 7787, 4683,
+4646, 847, 123, 293, 124, 1922, 7788, 7381, 1921, 1477, 7789,
+4647, 27, 808, 171, 170, 6323, 1831, 3590, 3591, 1830, 1406,
+4648, 1244, 674, 1277, 1260, 7679, 5561, 3406, 3347, 5563, 3405,
+4649, 1304, 1292, 1271, 665, 3491, 3482, 3492, 6926, 7790, 6697,
+4650, 1053, 454, 1013, 938, 6061, 5851, 2565, 2655, 6757, 2572,
+4651, 1276, 662, 1211, 1278, 7791, 6200, 3403, 3408, 7728, 3409,
+4652, 64, 63, 886, 209, 1587, 6185, 6186, 7670, 7721, 2028,
+4653, 473, 326, 362, 1050, 4421, 4096, 4419, 7266, 6691, 6692,
+4654, 549, 577, 480, 1084, 4774, 4773, 4677, 7437, 7793, 7792,
+4655, 498, 530, 1197, 608, 4776, 5656, 6009, 4884, 4883, 6012,
+4656, 778, 1366, 771, 1370, 7794, 6414, 5475, 6993, 1607, 7674,
+4657, 790, 789, 12, 333, 1778, 7796, 7795, 7686, 7797, 3972,
+4658, 562, 1088, 374, 957, 6130, 7267, 4711, 6129, 2708, 6646,
+4659, 326, 1051, 363, 895, 7262, 6419, 4073, 6683, 2557, 7798,
+4660, 325, 893, 361, 1048, 7595, 7038, 4095, 6676, 2549, 6868,
+4661, 897, 75, 364, 327, 5843, 4041, 5841, 7306, 3954, 4074,
+4662, 326, 894, 1050, 895, 6681, 2554, 6691, 6683, 2056, 2555,
+4663, 1153, 475, 1115, 497, 7615, 7616, 2983, 7765, 4514, 7799,
+4664, 175, 31, 342, 30, 3600, 3989, 6207, 3597, 1523, 3990,
+4665, 1064, 535, 536, 432, 5653, 4636, 5840, 5839, 4632, 4634,
+4666, 1153, 1115, 1073, 497, 2983, 2795, 3044, 7765, 7799, 7645,
+4667, 230, 336, 480, 953, 4077, 4445, 4444, 5606, 6998, 5607,
+4668, 1321, 715, 1332, 1303, 7257, 5868, 1724, 1736, 5867, 1737,
+4669, 452, 453, 1117, 574, 4360, 7800, 5532, 4758, 4757, 6237,
+4670, 1303, 715, 682, 661, 5867, 5285, 5866, 7045, 5227, 5128,
+4671, 661, 1298, 682, 1303, 6723, 6786, 5128, 7045, 3407, 5866,
+4672, 331, 225, 9, 786, 3991, 3679, 3966, 7089, 7090, 7100,
+4673, 38, 344, 309, 861, 3998, 4003, 3919, 6146, 6531, 6145,
+4674, 224, 939, 478, 784, 6987, 7801, 4436, 5700, 2229, 5699,
+4675, 682, 1298, 1332, 1303, 6786, 3159, 5869, 5866, 3407, 1737,
+4676, 195, 196, 51, 825, 1432, 7803, 7802, 1876, 1875, 7804,
+4677, 839, 179, 34, 1375, 2071, 5903, 6427, 6425, 6426, 6506,
+4678, 563, 1074, 1205, 603, 5646, 3188, 7805, 4865, 5930, 7441,
+4679, 727, 720, 1265, 1314, 5276, 6233, 6393, 7806, 6235, 3462,
+4680, 654, 1314, 1266, 720, 7807, 3268, 6251, 5247, 6235, 7362,
+4681, 550, 1200, 1231, 604, 7136, 3229, 7134, 4869, 7252, 7808,
+4682, 1377, 913, 264, 207, 6711, 6712, 6709, 7678, 2098, 7809,
+4683, 1331, 1313, 721, 1324, 3202, 6552, 6554, 1719, 3201, 6549,
+4684, 988, 1109, 989, 412, 2771, 2770, 2375, 6893, 6522, 5580,
+4685, 480, 577, 1085, 1084, 4773, 7810, 5622, 7792, 7793, 2701,
+4686, 594, 522, 1243, 593, 4831, 6155, 6345, 4833, 4830, 6637,
+4687, 1315, 1314, 1266, 654, 1741, 3268, 3269, 7233, 7807, 6251,
+4688, 727, 1314, 654, 720, 7806, 7807, 5275, 5276, 6235, 5247,
+4689, 1244, 1185, 629, 1260, 3291, 7656, 7654, 3347, 3346, 5590,
+4690, 990, 268, 267, 414, 6831, 3799, 7333, 6019, 4239, 4238,
+4691, 992, 420, 525, 1108, 6914, 4604, 7359, 2769, 6915, 7358,
+4692, 961, 806, 962, 233, 2295, 2297, 2299, 7811, 7813, 7812,
+4693, 770, 1336, 759, 1360, 7814, 7143, 5463, 6366, 1705, 5980,
+4694, 33, 32, 815, 177, 1525, 6605, 5749, 3604, 3601, 1851,
+4695, 969, 379, 968, 813, 7344, 5812, 2320, 2318, 5917, 2316,
+4696, 781, 143, 1374, 222, 1750, 6603, 7704, 2070, 1749, 7558,
+4697, 506, 1058, 1156, 395, 6766, 3010, 6765, 4540, 7013, 7815,
+4698, 782, 781, 144, 223, 1754, 1751, 1752, 5855, 6046, 6794,
+4699, 507, 1180, 1107, 621, 7782, 3008, 6016, 4922, 6094, 7535,
+4700, 924, 998, 285, 842, 2402, 7816, 6771, 2177, 2399, 7157,
+4701, 506, 1180, 507, 621, 6767, 7782, 4545, 4921, 6094, 4922,
+4702, 1360, 1336, 759, 1326, 1705, 7143, 5980, 1707, 1708, 5981,
+4703, 1172, 641, 1164, 1237, 7181, 6261, 2981, 3324, 5571, 3254,
+4704, 301, 134, 133, 99, 7224, 1487, 7222, 3896, 3656, 3655,
+4705, 909, 255, 402, 256, 6983, 4202, 7230, 6648, 3763, 4203,
+4706, 546, 445, 1167, 545, 4667, 5734, 5733, 4669, 4665, 6252,
+4707, 97, 130, 298, 96, 3650, 7343, 3888, 1546, 3649, 3887,
+4708, 1001, 922, 427, 841, 2409, 6578, 6577, 2408, 2223, 7783,
+4709, 1098, 613, 1189, 1195, 6501, 6547, 2972, 3057, 7537, 3058,
+4710, 141, 856, 142, 106, 1940, 1939, 1495, 3670, 7817, 3671,
+4711, 850, 297, 96, 129, 5834, 3885, 5832, 1928, 6025, 3648,
+4712, 532, 996, 1001, 428, 5718, 2411, 6293, 4622, 7819, 7818,
+4713, 285, 842, 429, 284, 7157, 6954, 4285, 3850, 6955, 4284,
+4714, 735, 1336, 1343, 1295, 7457, 1718, 7820, 7454, 3129, 1684,
+4715, 1343, 735, 770, 1336, 7820, 5433, 6969, 1718, 7457, 7814,
+4716, 770, 735, 759, 1336, 5433, 5456, 5463, 7814, 7457, 7143,
+4717, 502, 587, 1188, 620, 4809, 6034, 6074, 4810, 4812, 7587,
+4718, 1375, 107, 78, 839, 6424, 3608, 6504, 6425, 1906, 6505,
+4719, 670, 1304, 711, 665, 7128, 6925, 5216, 5121, 6926, 5215,
+4720, 1287, 731, 722, 1347, 6930, 5294, 7821, 2654, 7284, 7285,
+4721, 722, 1305, 1287, 1347, 7822, 2662, 7821, 7285, 1743, 2654,
+4722, 852, 301, 934, 134, 7223, 7215, 2187, 1931, 7224, 2145,
+4723, 934, 301, 100, 134, 7215, 3897, 7205, 2145, 7224, 3657,
+4724, 8, 146, 7, 224, 3548, 3545, 1500, 3676, 7823, 3677,
+4725, 309, 453, 1016, 344, 4358, 7824, 7518, 4003, 4359, 5835,
+4726, 617, 1257, 1266, 1264, 6629, 3373, 6250, 7227, 2984, 3374,
+4727, 548, 1183, 1158, 495, 6802, 3021, 6572, 4746, 7520, 6573,
+4728, 1363, 744, 1339, 1322, 7743, 6912, 1663, 1687, 7825, 1686,
+4729, 398, 508, 980, 1102, 4547, 6510, 7826, 6990, 6991, 2754,
+4730, 1363, 1356, 744, 1322, 1636, 7614, 7743, 1687, 1688, 7825,
+4731, 109, 281, 921, 840, 7389, 5695, 2117, 1908, 5696, 2118,
+4732, 461, 381, 492, 1128, 4387, 4504, 4503, 6620, 7263, 7827,
+4733, 1001, 841, 428, 996, 2408, 5711, 7818, 2411, 2394, 7819,
+4734, 306, 343, 1011, 937, 4356, 7102, 7103, 6429, 7828, 2435,
+4735, 1028, 873, 351, 872, 2489, 6623, 6565, 2488, 1990, 6590,
+4736, 392, 245, 821, 973, 4172, 7769, 7641, 7453, 7770, 2330,
+4737, 51, 874, 196, 873, 7280, 1991, 7803, 7829, 1993, 1989,
+4738, 492, 1129, 461, 1128, 7502, 6619, 4503, 7827, 2838, 6620,
+4739, 939, 783, 367, 938, 2228, 6882, 6752, 2230, 2227, 6754,
+4740, 1375, 1, 78, 107, 7187, 1527, 6504, 6424, 3607, 3608,
+4741, 1199, 1228, 1130, 579, 3218, 3217, 3194, 6747, 6694, 6696,
+4742, 957, 481, 956, 801, 7242, 5623, 2284, 2282, 5872, 2280,
+4743, 1352, 1372, 1364, 772, 1614, 1613, 1615, 6474, 6475, 6482,
+4744, 1372, 744, 1363, 1356, 7830, 7743, 1630, 1635, 7614, 1636,
+4745, 165, 164, 22, 802, 1400, 3580, 3579, 1813, 1812, 7104,
+4746, 22, 164, 231, 802, 3580, 7195, 3690, 7104, 1812, 7336,
+4747, 393, 246, 978, 904, 4175, 7459, 7719, 7831, 7460, 2441,
+4748, 1361, 766, 779, 1369, 7833, 5478, 7832, 1628, 7834, 7245,
+4749, 779, 766, 767, 1369, 5478, 5471, 5476, 7245, 7834, 7652,
+4750, 1340, 763, 1294, 1338, 5969, 7835, 3261, 1681, 6612, 3213,
+4751, 767, 766, 756, 1369, 5471, 5421, 5453, 7652, 7834, 6284,
+4752, 519, 628, 1194, 1185, 4940, 6143, 6133, 7427, 6142, 3056,
+4753, 416, 1103, 1111, 1061, 7115, 2780, 6167, 7116, 2756, 2777,
+4754, 969, 425, 424, 379, 7050, 4274, 5895, 7344, 4460, 4617,
+4755, 325, 1048, 1049, 893, 6676, 2553, 6610, 7595, 2549, 2551,
+4756, 161, 798, 230, 799, 1801, 6999, 6785, 1803, 1805, 6996,
+4757, 1327, 739, 727, 1344, 6442, 5381, 7836, 1728, 6845, 7837,
+4758, 1056, 503, 504, 393, 7382, 4536, 6588, 7720, 4533, 4534,
+4759, 474, 1152, 1153, 1051, 6597, 2910, 7763, 6418, 2906, 2908,
+4760, 1056, 393, 978, 904, 7720, 7719, 2578, 2576, 7831, 2441,
+4761, 1354, 767, 756, 1369, 6365, 5453, 6282, 1651, 7652, 6284,
+4762, 582, 1121, 1122, 458, 6215, 2817, 7838, 4798, 7211, 6301,
+4763, 384, 1121, 582, 458, 5949, 6215, 4766, 4376, 7211, 4798,
+4764, 902, 39, 184, 819, 7036, 7514, 2077, 2220, 7146, 1863,
+4765, 423, 1159, 528, 422, 5710, 5708, 4612, 4267, 6688, 4611,
+4766, 660, 579, 1199, 647, 5064, 6747, 6865, 5066, 5000, 6559,
+4767, 782, 6, 144, 145, 6793, 3544, 1752, 1753, 3543, 1380,
+4768, 528, 1159, 1096, 1095, 5708, 3005, 5662, 7085, 3163, 2739,
+4769, 55, 878, 56, 200, 7840, 7839, 1579, 7841, 2003, 7842,
+4770, 1287, 722, 714, 1286, 7821, 5255, 7667, 3439, 7844, 7843,
+4771, 422, 1159, 994, 423, 6688, 2932, 6687, 4267, 5710, 6689,
+4772, 681, 1173, 705, 746, 6262, 7845, 5286, 5308, 5853, 5309,
+4773, 265, 831, 989, 988, 7575, 2374, 5578, 6897, 2371, 2375,
+4774, 705, 1155, 1112, 1173, 7846, 2920, 5756, 7845, 2991, 2990,
+4775, 1273, 1236, 747, 1192, 3392, 5556, 5559, 3391, 3252, 5938,
+4776, 1265, 1236, 746, 1273, 3371, 5557, 5852, 3393, 3392, 5558,
+4777, 392, 246, 393, 904, 4173, 4175, 4177, 7642, 7460, 7831,
+4778, 275, 421, 1062, 422, 4260, 6064, 7072, 4262, 4264, 6065,
+4779, 1376, 273, 918, 71, 7024, 7339, 7069, 7025, 3813, 7338,
+4780, 837, 919, 276, 74, 2206, 6026, 7847, 7775, 6027, 3822,
+4781, 917, 835, 1376, 273, 2204, 6964, 6962, 7848, 7340, 7024,
+4782, 330, 454, 367, 938, 4362, 4364, 4114, 6870, 6757, 6754,
+4783, 1145, 576, 551, 1202, 5598, 4770, 7849, 3086, 6486, 7736,
+4784, 814, 236, 969, 813, 5613, 7051, 2319, 1850, 7850, 2318,
+4785, 678, 642, 679, 1237, 5113, 5114, 5116, 5570, 5572, 7310,
+4786, 301, 933, 133, 852, 7851, 2142, 7222, 7223, 2214, 1932,
+4787, 1361, 1357, 766, 1369, 1652, 7046, 7833, 1628, 1653, 7834,
+4788, 561, 1235, 1148, 1147, 6826, 3243, 6727, 6114, 3242, 2895,
+4789, 1100, 1183, 495, 1158, 3053, 7520, 7852, 2943, 3021, 6573,
+4790, 1056, 392, 393, 904, 7384, 4177, 7720, 2576, 7642, 7831,
+4791, 935, 303, 448, 304, 7697, 4341, 6123, 6125, 3907, 4342,
+4792, 1147, 1202, 561, 1235, 3088, 6825, 6114, 3242, 3244, 6826,
+4793, 633, 535, 536, 1155, 4955, 4636, 4956, 7742, 5654, 6354,
+4794, 1144, 602, 1234, 1233, 7401, 7853, 3239, 3237, 7404, 3241,
+4795, 66, 915, 210, 211, 6334, 2103, 7854, 6335, 2102, 1447,
+4796, 352, 873, 1029, 874, 7855, 2491, 7500, 7270, 1993, 2492,
+4797, 65, 915, 66, 268, 6796, 6334, 1589, 3797, 6832, 3798,
+4798, 660, 647, 1199, 1285, 5066, 6559, 6865, 7723, 5538, 3468,
+4799, 506, 621, 505, 1180, 4921, 4816, 4542, 6767, 6094, 6093,
+4800, 833, 915, 268, 66, 2202, 6832, 6830, 6333, 6334, 3798,
+4801, 179, 1375, 142, 237, 6426, 7856, 1858, 5823, 7858, 7857,
+4802, 683, 590, 694, 1242, 5130, 5168, 5184, 7859, 7481, 6104,
+4803, 339, 24, 804, 167, 3984, 5616, 5615, 6759, 3583, 1819,
+4804, 768, 775, 764, 1368, 5489, 5483, 5429, 6264, 6267, 6448,
+4805, 1118, 380, 1119, 599, 7860, 5954, 2808, 7675, 4850, 6166,
+4806, 528, 1096, 584, 1095, 5662, 5648, 4843, 7085, 2739, 5649,
+4807, 483, 1093, 963, 962, 7137, 2724, 7139, 7398, 2723, 2302,
+4808, 965, 964, 568, 1094, 2308, 7861, 5638, 2730, 2729, 5640,
+4809, 833, 66, 268, 269, 6333, 3798, 6830, 6805, 3800, 3802,
+4810, 1298, 645, 682, 659, 6724, 5126, 6786, 6788, 5062, 5127,
+4811, 1218, 1190, 527, 1162, 3178, 6306, 6494, 3177, 3042, 6307,
+4812, 73, 895, 363, 896, 7862, 7798, 4039, 7322, 2059, 7316,
+4813, 418, 525, 1110, 992, 4601, 7357, 5919, 5920, 7359, 2773,
+4814, 845, 289, 119, 926, 7163, 7162, 1918, 2209, 7863, 2127,
+4815, 633, 1191, 681, 655, 6798, 7864, 5124, 5111, 7865, 5123,
+4816, 991, 271, 418, 834, 7217, 4250, 5918, 2380, 6210, 7866,
+4817, 850, 129, 96, 130, 1928, 3648, 5832, 1927, 1483, 3649,
+4818, 544, 443, 1007, 543, 4661, 7174, 7867, 4663, 4660, 7063,
+4819, 857, 179, 34, 839, 1941, 5903, 6051, 2225, 2071, 6427,
+4820, 1089, 1213, 583, 1214, 3140, 7750, 6217, 3143, 3145, 6218,
+4821, 1011, 343, 1012, 937, 7102, 7540, 2439, 2435, 7828, 2438,
+4822, 1199, 1228, 606, 1286, 3218, 6678, 6864, 3483, 3498, 6067,
+4823, 649, 1213, 583, 1089, 6138, 7750, 5025, 6136, 3140, 6217,
+4824, 1229, 1301, 1261, 600, 3496, 3512, 3351, 7868, 7869, 7639,
+4825, 1195, 632, 655, 1191, 6182, 5047, 7870, 3248, 6184, 7865,
+4826, 1200, 1268, 604, 614, 3471, 7871, 7252, 6469, 6470, 5005,
+4827, 1197, 530, 498, 1124, 5656, 4776, 6009, 3065, 6729, 6404,
+4828, 1107, 1193, 621, 1180, 3051, 6092, 7535, 3008, 3052, 6094,
+4829, 430, 533, 429, 998, 4626, 4625, 4289, 7487, 7484, 5715,
+4830, 1101, 1245, 516, 1105, 3295, 7507, 6816, 2762, 3296, 6817,
+4831, 1375, 1, 142, 237, 7187, 3672, 7856, 7858, 3704, 7857,
+4832, 856, 179, 142, 237, 2069, 1858, 1939, 6580, 5823, 7857,
+4833, 446, 1069, 934, 1070, 7371, 2630, 7226, 6872, 2652, 2633,
+4834, 1269, 663, 679, 672, 6857, 5122, 6852, 7585, 5171, 5252,
+4835, 317, 1032, 1033, 877, 7328, 2505, 7327, 7493, 2501, 2503,
+4836, 1169, 546, 642, 643, 6300, 4984, 5727, 6258, 4986, 4988,
+4837, 424, 994, 1097, 423, 5628, 2785, 5627, 4270, 6689, 5723,
+4838, 220, 278, 837, 920, 7873, 7872, 1899, 2113, 5894, 2175,
+4839, 1067, 1172, 1008, 545, 2980, 2970, 2644, 7776, 6253, 7583,
+4840, 813, 236, 969, 379, 7850, 7051, 2318, 5917, 4137, 7344,
+4841, 591, 1245, 1101, 1224, 7508, 3295, 6513, 6976, 3298, 3196,
+4842, 44, 189, 45, 822, 7875, 7874, 1568, 7513, 1870, 6658,
+4843, 118, 288, 844, 926, 7876, 7563, 1915, 2128, 7877, 2179,
+4844, 373, 565, 1085, 577, 4722, 6380, 5621, 4775, 4787, 7810,
+4845, 1306, 667, 650, 1293, 6392, 5082, 7683, 3041, 6744, 6308,
+4846, 831, 265, 1377, 913, 7575, 6710, 7572, 2200, 6713, 6711,
+4847, 829, 204, 1373, 912, 1883, 7250, 7878, 2167, 2097, 6376,
+4848, 358, 886, 1042, 322, 6187, 2530, 7400, 4092, 6190, 7879,
+4849, 650, 1293, 560, 1235, 6308, 6309, 5015, 7880, 3500, 6044,
+4850, 868, 312, 1023, 867, 7590, 5698, 2474, 1975, 6399, 2473,
+4851, 43, 866, 188, 865, 5587, 1967, 5778, 5780, 1969, 1965,
+4852, 650, 560, 561, 1235, 5015, 4710, 5016, 7880, 6044, 6826,
+4853, 463, 1132, 1133, 1031, 5795, 2850, 5945, 5796, 2846, 2848,
+4854, 1266, 1247, 720, 1314, 3375, 6234, 7362, 3268, 3530, 6235,
+4855, 560, 1235, 1293, 1203, 6044, 3500, 6309, 6803, 3247, 3458,
+4856, 1130, 488, 1131, 579, 6695, 7501, 2844, 6696, 4785, 6748,
+4857, 119, 289, 87, 926, 7162, 3860, 3629, 2127, 7863, 7881,
+4858, 507, 1180, 979, 1107, 7782, 3009, 7620, 6016, 3008, 2767,
+4859, 44, 866, 867, 189, 5588, 1972, 6397, 7875, 1968, 1970,
+4860, 492, 1228, 1198, 619, 6677, 3219, 7882, 4914, 6679, 6704,
+4861, 1295, 697, 1281, 1323, 7456, 6357, 3205, 1698, 5672, 3204,
+4862, 1111, 415, 416, 1061, 5516, 4246, 6167, 2777, 5518, 7116,
+4863, 595, 664, 1284, 1217, 5076, 6571, 7883, 6749, 6750, 3440,
+4864, 87, 118, 119, 926, 3628, 1472, 3629, 7881, 2128, 2127,
+4865, 527, 422, 1162, 421, 4609, 6066, 6307, 4608, 4264, 6063,
+4866, 1252, 1246, 748, 708, 3326, 7685, 6784, 6071, 6072, 5347,
+4867, 218, 73, 219, 896, 6097, 6098, 1455, 2057, 7322, 2058,
+4868, 1349, 1368, 764, 774, 1621, 6448, 6447, 7471, 6479, 5450,
+4869, 1329, 763, 777, 754, 6611, 5467, 7288, 7884, 5407, 5468,
+4870, 339, 805, 25, 167, 5496, 7885, 3983, 6759, 1821, 3586,
+4871, 978, 393, 394, 247, 7719, 4180, 7664, 7461, 4176, 4178,
+4872, 231, 481, 957, 801, 4446, 7242, 7241, 5870, 5872, 2282,
+4873, 771, 1366, 778, 751, 6414, 7794, 5475, 5440, 6416, 5470,
+4874, 1298, 1285, 659, 1305, 3469, 7511, 6788, 3089, 3494, 6968,
+4875, 902, 820, 185, 40, 2156, 1866, 2076, 7035, 5902, 5900,
+4876, 1286, 722, 660, 1305, 7844, 5253, 6068, 3493, 7822, 7886,
+4877, 1112, 634, 705, 635, 7468, 5199, 5756, 5926, 4963, 5200,
+4878, 660, 1285, 1286, 1305, 7723, 3484, 6068, 7886, 3494, 3493,
+4879, 660, 722, 659, 1305, 5253, 5256, 5139, 7886, 7822, 6968,
+4880, 506, 395, 1156, 505, 4540, 7815, 6765, 4542, 4538, 6172,
+4881, 659, 1285, 660, 1305, 7511, 7723, 5139, 6968, 3494, 7886,
+4882, 340, 962, 963, 807, 7759, 2302, 7613, 7677, 2298, 2300,
+4883, 1255, 1246, 748, 1252, 3334, 7685, 7378, 3336, 3326, 6784,
+4884, 829, 59, 1373, 204, 7887, 6927, 7878, 1883, 7251, 7250,
+4885, 207, 206, 264, 61, 1443, 6934, 7809, 7888, 6680, 3785,
+4886, 664, 1216, 1282, 1283, 7890, 3430, 7889, 7577, 3431, 3112,
+4887, 596, 1095, 568, 1094, 7084, 5639, 4905, 5527, 2734, 5640,
+4888, 1187, 514, 626, 515, 5933, 4824, 7891, 7490, 4571, 4934,
+4889, 1216, 1215, 612, 1282, 3154, 6842, 7892, 3430, 3425, 7020,
+4890, 1057, 406, 514, 515, 6395, 4567, 5932, 7414, 4569, 4571,
+4891, 572, 1093, 483, 1092, 7554, 7137, 4751, 7555, 2725, 7397,
+4892, 1266, 1257, 617, 656, 3373, 6629, 6250, 5785, 6175, 5051,
+4893, 1195, 655, 646, 1257, 7870, 5050, 7533, 3341, 7893, 6630,
+4894, 1304, 1315, 712, 1314, 1740, 7127, 7129, 1739, 1741, 7894,
+4895, 1110, 523, 1219, 524, 6599, 7702, 3165, 5936, 4600, 7153,
+4896, 199, 877, 54, 200, 2000, 7712, 6768, 1436, 2001, 6769,
+4897, 768, 776, 1351, 739, 5462, 7312, 7311, 5428, 5459, 6441,
+4898, 44, 822, 45, 247, 7513, 6658, 1568, 3734, 6659, 3735,
+4899, 418, 272, 834, 271, 4251, 6209, 7866, 4250, 3811, 6210,
+4900, 1189, 574, 613, 531, 5955, 4897, 6547, 6229, 4803, 4898,
+4901, 879, 202, 56, 201, 2007, 7495, 7895, 2006, 1438, 6331,
+4902, 1238, 683, 743, 1312, 6863, 5331, 7896, 3528, 7753, 7509,
+4903, 111, 283, 282, 922, 7156, 3844, 7155, 2119, 7784, 7165,
+4904, 1327, 773, 1318, 752, 6439, 7897, 1730, 7206, 5443, 7898,
+4905, 142, 1, 106, 237, 3672, 1556, 3671, 7857, 3704, 3703,
+4906, 94, 127, 296, 930, 3644, 6910, 3881, 6961, 2136, 7747,
+4907, 262, 60, 1373, 59, 3780, 6732, 7424, 3779, 1583, 6927,
+4908, 646, 655, 656, 1257, 5050, 5053, 5052, 6630, 7893, 6175,
+4909, 1066, 433, 434, 289, 5815, 4301, 7341, 7899, 4297, 4299,
+4910, 879, 56, 57, 318, 7895, 1580, 7900, 7651, 3937, 3936,
+4911, 656, 1257, 655, 1191, 6175, 7893, 5053, 5787, 3340, 7865,
+4912, 298, 130, 97, 932, 7343, 3650, 3888, 5740, 2141, 7755,
+4913, 655, 1257, 1195, 1191, 7893, 3341, 7870, 7865, 3340, 3248,
+4914, 303, 102, 137, 136, 3903, 3662, 7695, 7696, 3661, 1490,
+4915, 1332, 1349, 737, 1352, 1720, 7470, 7183, 1721, 1633, 6481,
+4916, 1332, 1349, 1341, 733, 1720, 1692, 1732, 7184, 7469, 7548,
+4917, 45, 46, 248, 905, 1569, 3738, 3737, 6657, 6462, 6463,
+4918, 479, 795, 951, 796, 6285, 2264, 7295, 7607, 1796, 2265,
+4919, 870, 47, 869, 192, 6781, 7901, 1981, 1979, 7259, 1977,
+4920, 737, 1349, 1332, 733, 7470, 1720, 7183, 5385, 7469, 7184,
+4921, 769, 1348, 1352, 1370, 7672, 1647, 6472, 6992, 1641, 1627,
+4922, 72, 918, 274, 71, 5536, 6670, 3816, 1595, 7338, 3815,
+4923, 990, 832, 267, 915, 2378, 5549, 7333, 2377, 2170, 6797,
+4924, 67, 211, 66, 889, 7446, 6335, 1590, 7237, 2036, 5819,
+4925, 1352, 1372, 769, 1370, 1614, 6473, 6472, 1627, 1626, 6992,
+4926, 889, 211, 66, 888, 2036, 6335, 5819, 2038, 2034, 5821,
+4927, 664, 1283, 1282, 1316, 7577, 3112, 7889, 7576, 3114, 3113,
+4928, 767, 1371, 779, 1369, 6527, 6525, 5476, 7652, 1631, 7245,
+4929, 833, 211, 67, 212, 1892, 7446, 6800, 1891, 1448, 6801,
+4930, 771, 1367, 738, 1348, 6537, 7902, 5437, 7673, 1640, 6616,
+4931, 1185, 629, 520, 592, 7656, 4943, 6361, 7657, 4942, 4828,
+4932, 1200, 1301, 604, 1268, 3480, 7903, 7252, 3471, 3481, 7871,
+4933, 1353, 1324, 750, 1348, 1697, 7904, 6613, 1660, 1696, 6614,
+4934, 289, 288, 87, 926, 3862, 3858, 3860, 7863, 7877, 7881,
+4935, 6, 223, 144, 5, 3674, 6794, 3544, 1498, 3675, 3541,
+4936, 465, 487, 1035, 1136, 4472, 5505, 7452, 7542, 7578, 2858,
+4937, 930, 93, 94, 126, 7463, 1543, 6961, 2137, 3642, 3643,
+4938, 34, 179, 237, 1375, 5903, 5823, 3705, 6506, 6426, 7858,
+4939, 1189, 531, 613, 532, 6229, 4898, 6547, 5983, 4624, 4949,
+4940, 749, 1251, 692, 755, 7497, 7419, 5349, 5375, 6943, 5373,
+4941, 1022, 348, 1021, 866, 7905, 7092, 2472, 2470, 5589, 2468,
+4942, 553, 1135, 1136, 464, 7387, 2859, 7386, 4686, 7692, 7543,
+4943, 144, 223, 781, 5, 6794, 6046, 1751, 3541, 3675, 5603,
+4944, 880, 355, 319, 1036, 6325, 4089, 5594, 2512, 5504, 7353,
+4945, 1139, 1038, 467, 1037, 2867, 7547, 7906, 2866, 2520, 7907,
+4946, 715, 750, 1321, 769, 5354, 7258, 7257, 5431, 5430, 7908,
+4947, 604, 1301, 1200, 1231, 7903, 3480, 7252, 7808, 3497, 3229,
+4948, 716, 581, 1177, 1279, 5230, 5510, 7909, 7003, 5512, 3415,
+4949, 1373, 205, 912, 204, 6375, 2096, 6376, 7250, 1441, 2097,
+4950, 320, 882, 1038, 883, 7138, 2518, 7910, 6673, 2020, 2519,
+4951, 1039, 883, 320, 1038, 2521, 6673, 7911, 2523, 2519, 7910,
+4952, 1095, 528, 596, 584, 7085, 4840, 7084, 5649, 4843, 4842,
+4953, 320, 467, 490, 1038, 4403, 4485, 4484, 7910, 7547, 7546,
+4954, 535, 1063, 1064, 1157, 5910, 2613, 5653, 5655, 2945, 2994,
+4955, 837, 277, 276, 994, 7221, 3826, 7847, 2388, 7154, 7912,
+4956, 1325, 1279, 676, 716, 3429, 6508, 6507, 6734, 7003, 5229,
+4957, 1038, 882, 356, 1037, 2518, 7298, 7913, 2520, 2516, 7235,
+4958, 1325, 716, 676, 719, 6734, 5229, 6507, 6736, 5240, 5239,
+4959, 1085, 1212, 1084, 577, 3133, 3132, 2701, 7810, 6718, 7793,
+4960, 1178, 1212, 1085, 611, 3136, 3133, 3135, 5909, 6382, 6381,
+4961, 848, 930, 295, 1003, 2183, 7462, 7464, 2414, 2627, 7914,
+4962, 866, 311, 43, 348, 7682, 3922, 5587, 5589, 4058, 4009,
+4963, 633, 1155, 536, 634, 7742, 6354, 4956, 4960, 7478, 4958,
+4964, 1375, 179, 142, 3, 6426, 1858, 7856, 6763, 1415, 1496,
+4965, 1154, 456, 999, 1014, 5790, 7193, 2914, 2911, 6116, 2792,
+4966, 34, 839, 78, 280, 6427, 6505, 3833, 3963, 6353, 3834,
+4967, 440, 1003, 930, 849, 7498, 2627, 7754, 6907, 2580, 2211,
+4968, 1079, 946, 947, 477, 2675, 2254, 2676, 7915, 7917, 7916,
+4969, 1020, 311, 1021, 458, 6088, 7093, 2469, 6086, 4374, 6302,
+4970, 229, 335, 479, 796, 4076, 4443, 4442, 7918, 7606, 7607,
+4971, 581, 1279, 716, 676, 5512, 7003, 5230, 5110, 6508, 5229,
+4972, 154, 227, 792, 791, 7499, 6790, 1782, 1780, 6101, 1784,
+4973, 420, 835, 992, 419, 7057, 2384, 6914, 4258, 7762, 7617,
+4974, 650, 1235, 561, 1290, 7880, 6826, 5016, 7684, 3503, 6827,
+4975, 891, 68, 214, 69, 7919, 6783, 2043, 7920, 1592, 7079,
+4976, 87, 288, 118, 926, 3858, 7876, 3628, 7881, 7877, 2128,
+4977, 198, 909, 199, 256, 2091, 2090, 1435, 7716, 6648, 6407,
+4978, 823, 250, 396, 906, 7042, 4185, 7921, 2161, 7021, 6546,
+4979, 494, 1090, 583, 571, 5530, 6216, 4800, 4795, 7313, 4799,
+4980, 1373, 60, 830, 205, 6732, 5688, 6374, 6375, 6649, 1886,
+4981, 404, 827, 910, 984, 5977, 2165, 5498, 5499, 2361, 2360,
+4982, 398, 1102, 980, 981, 6990, 2754, 7826, 7922, 2753, 2353,
+4983, 198, 256, 54, 53, 7716, 3762, 7714, 6451, 3761, 1577,
+4984, 869, 47, 870, 313, 7901, 6781, 1981, 7634, 3926, 6782,
+4985, 1238, 743, 1300, 1312, 7896, 6815, 3478, 3528, 7509, 3379,
+4986, 384, 347, 1020, 458, 4150, 6087, 5951, 4376, 4375, 6086,
+4987, 1198, 1127, 1128, 566, 3211, 2835, 3070, 6703, 7630, 7638,
+4988, 622, 1179, 1251, 1193, 7345, 3319, 7420, 7346, 3176, 3320,
+4989, 1253, 689, 691, 589, 7123, 5259, 7599, 7124, 5154, 5157,
+4990, 413, 267, 914, 266, 4236, 5548, 5546, 4235, 3796, 5582,
+4991, 414, 520, 1055, 521, 4588, 7725, 5857, 4589, 4591, 7923,
+4992, 1320, 1306, 704, 1335, 3232, 6203, 6372, 1616, 3357, 6205,
+4993, 726, 689, 1297, 1289, 5272, 6595, 6594, 7364, 7365, 3192,
+4994, 726, 1289, 745, 700, 7364, 7924, 5338, 5271, 7278, 5337,
+4995, 856, 105, 141, 937, 7925, 3669, 1940, 2218, 7926, 2150,
+4996, 1302, 1267, 648, 1296, 3487, 6489, 6487, 3486, 3465, 7505,
+4997, 1174, 512, 625, 513, 6458, 4931, 7524, 7472, 4564, 4932,
+4998, 55, 257, 54, 200, 3765, 3764, 1578, 7841, 5984, 6769,
+4999, 1079, 598, 369, 1080, 6389, 4848, 7927, 2680, 6900, 7928,
+5000, 1081, 948, 369, 1080, 2681, 6438, 6437, 2683, 2679, 7928,
+5001, 624, 1238, 693, 623, 6848, 6862, 5167, 4930, 6847, 5166,
+5002, 1290, 685, 1272, 618, 7741, 7249, 3452, 7929, 5136, 6904,
+5003, 1287, 722, 1286, 1305, 7821, 7844, 3439, 2662, 7822, 3493,
+5004, 880, 355, 318, 57, 6325, 4065, 7650, 6326, 4023, 3936,
+5005, 470, 322, 1043, 359, 4412, 7745, 6715, 4411, 4069, 7624,
+5006, 1042, 887, 1043, 322, 2531, 2533, 2535, 7879, 6191, 7745,
+5007, 879, 202, 880, 57, 2007, 2009, 2011, 7900, 6242, 6326,
+5008, 1217, 1094, 1218, 596, 3158, 3160, 3162, 5528, 5527, 6496,
+5009, 595, 1217, 1284, 1190, 6749, 3440, 7883, 6053, 3433, 3441,
+5010, 1136, 1135, 1034, 464, 2859, 2855, 2857, 7543, 7692, 7707,
+5011, 657, 1301, 604, 600, 7930, 7903, 5055, 5056, 7869, 4868,
+5012, 1306, 1290, 650, 685, 3040, 7684, 7683, 6204, 7741, 5135,
+5013, 276, 1062, 275, 919, 7931, 7072, 3823, 6026, 2605, 7261,
+5014, 887, 65, 359, 322, 7449, 4031, 7448, 6191, 3944, 4069,
+5015, 553, 1229, 1301, 1231, 7933, 3496, 7932, 7385, 3221, 3497,
+5016, 887, 322, 359, 1043, 6191, 4069, 7448, 2533, 7745, 7624,
+5017, 600, 1301, 604, 553, 7869, 7903, 4868, 4852, 7932, 4867,
+5018, 668, 684, 648, 1267, 5133, 5132, 5083, 6490, 7733, 6489,
+5019, 713, 732, 756, 1345, 5300, 5378, 5380, 7018, 7935, 7934,
+5020, 1042, 322, 1043, 486, 7879, 7745, 2535, 7936, 4468, 6716,
+5021, 771, 1370, 769, 778, 7674, 6992, 5436, 5475, 6993, 5474,
+5022, 253, 982, 825, 908, 5761, 2356, 6719, 7937, 2355, 2163,
+5023, 737, 774, 1364, 1349, 5448, 6485, 6480, 7470, 7471, 1623,
+5024, 278, 220, 837, 75, 7873, 1899, 7872, 3827, 7120, 7121,
+5025, 1057, 515, 514, 1187, 7414, 4571, 5932, 3030, 7490, 5933,
+5026, 518, 591, 1101, 1194, 4938, 6513, 5826, 6135, 6607, 3055,
+5027, 769, 1352, 737, 772, 6472, 6481, 5434, 5438, 6474, 5439,
+5028, 1220, 709, 1240, 678, 6152, 6153, 3277, 6368, 5234, 6287,
+5029, 1000, 1171, 538, 1054, 2978, 6312, 7373, 2570, 2979, 6311,
+5030, 221, 278, 220, 920, 6860, 7873, 1457, 2112, 5894, 2113,
+5031, 220, 278, 221, 75, 7873, 6860, 1457, 7120, 3827, 7729,
+5032, 1324, 668, 721, 725, 6550, 5282, 6549, 6634, 5268, 5283,
+5033, 60, 206, 830, 205, 5689, 1885, 5688, 6649, 1442, 1886,
+5034, 1055, 1182, 1111, 521, 3017, 3019, 2779, 7923, 7148, 6822,
+5035, 1343, 756, 1330, 1357, 6970, 7938, 1678, 1672, 6283, 1679,
+5036, 1302, 1324, 668, 1313, 3522, 6550, 6488, 3523, 3201, 6551,
+5037, 1133, 1132, 463, 564, 2850, 5795, 5945, 6965, 5974, 4718,
+5038, 837, 277, 75, 74, 7221, 3825, 7121, 7775, 3824, 1598,
+5039, 757, 764, 1365, 768, 5411, 6932, 6435, 5427, 5429, 6265,
+5040, 671, 1345, 1277, 1309, 7016, 2697, 5560, 6292, 1747, 2968,
+5041, 1334, 760, 702, 743, 6973, 5395, 6003, 6974, 5394, 5364,
+5042, 318, 354, 1034, 879, 4088, 7528, 7767, 7651, 7529, 2507,
+5043, 701, 744, 724, 1322, 5335, 5334, 5333, 7939, 7825, 7626,
+5044, 731, 1347, 757, 728, 7284, 6556, 5382, 5372, 7286, 5384,
+5045, 1309, 1323, 723, 729, 3412, 5673, 6391, 6497, 5928, 5313,
+5046, 604, 1301, 1231, 553, 7903, 3497, 7808, 4867, 7932, 7385,
+5047, 657, 1301, 1303, 1268, 7930, 3489, 7940, 7941, 3481, 3490,
+5048, 971, 838, 279, 816, 2326, 6823, 6869, 2325, 1903, 6121,
+5049, 746, 1273, 747, 752, 5558, 5559, 5342, 5362, 6901, 5403,
+5050, 712, 1344, 1304, 1314, 7942, 2728, 7129, 7894, 2727, 1739,
+5051, 386, 495, 385, 1158, 4793, 4511, 4156, 7592, 6573, 7596,
+5052, 451, 1018, 1120, 1019, 7569, 2809, 5942, 7265, 2463, 2810,
+5053, 451, 578, 1120, 1119, 4777, 5944, 5942, 5952, 5953, 2811,
+5054, 287, 431, 286, 843, 4291, 4290, 3856, 6960, 7071, 5882,
+5055, 276, 277, 837, 74, 3826, 7221, 7847, 3822, 3824, 7775,
+5056, 657, 1301, 600, 1303, 7930, 7869, 5056, 7940, 3489, 7943,
+5057, 1315, 654, 1264, 608, 7233, 7228, 3532, 6057, 5038, 6011,
+5058, 1220, 640, 1186, 709, 6370, 6518, 3169, 6152, 5212, 6151,
+5059, 1329, 1300, 1297, 754, 3125, 3427, 3130, 7884, 7944, 6606,
+5060, 780, 1329, 758, 1334, 7287, 7945, 5486, 6521, 1709, 6972,
+5061, 287, 117, 86, 288, 7946, 3626, 3855, 3859, 7562, 3857,
+5062, 514, 1106, 1187, 1223, 5934, 3031, 5933, 6150, 3186, 3257,
+5063, 1116, 512, 401, 511, 6459, 4558, 7438, 5513, 4560, 4556,
+5064, 1256, 1289, 688, 700, 3449, 7377, 7605, 7276, 7278, 5183,
+5065, 483, 962, 340, 233, 7398, 7759, 4451, 4452, 7812, 4053,
+5066, 1312, 1311, 694, 702, 3529, 5985, 7947, 6004, 5986, 5190,
+5067, 445, 1008, 933, 852, 7173, 2429, 7172, 7948, 2428, 2214,
+5068, 166, 804, 232, 24, 1818, 5614, 5650, 3584, 5616, 3692,
+5069, 1361, 1369, 779, 1367, 1628, 7245, 7832, 1619, 1629, 6538,
+5070, 209, 267, 210, 64, 6671, 6672, 1446, 7670, 3794, 7669,
+5071, 759, 1325, 1326, 1336, 7142, 3270, 5981, 7143, 3271, 1708,
+5072, 445, 852, 933, 301, 7948, 2214, 7172, 4333, 7223, 7851,
+5073, 358, 469, 1041, 321, 4407, 6015, 7399, 4068, 4408, 7351,
+5074, 933, 98, 851, 300, 7950, 7949, 2186, 7479, 3893, 7951,
+5075, 98, 933, 851, 132, 7950, 2186, 7949, 3653, 2143, 1929,
+5076, 364, 1053, 1013, 898, 5636, 2565, 6060, 5842, 2564, 2445,
+5077, 444, 299, 851, 443, 4329, 6896, 5767, 4331, 4327, 6895,
+5078, 339, 805, 961, 233, 5496, 2294, 5495, 4080, 7952, 7811,
+5079, 758, 1300, 749, 755, 6814, 7629, 5452, 5388, 6813, 5375,
+5080, 250, 906, 47, 48, 7021, 7041, 3743, 3744, 7953, 1571,
+5081, 1302, 1296, 648, 614, 3486, 7505, 6487, 6774, 6471, 5008,
+5082, 45, 867, 868, 190, 6398, 1975, 6772, 6775, 1971, 1973,
+5083, 351, 315, 1028, 461, 4085, 5998, 6565, 4385, 4388, 6566,
+5084, 394, 248, 978, 247, 4179, 7954, 7664, 4178, 3739, 7461,
+5085, 47, 46, 823, 249, 1570, 6461, 7040, 3741, 3740, 6751,
+5086, 1297, 1300, 749, 754, 3427, 7629, 7597, 6606, 7944, 5447,
+5087, 1308, 1339, 1310, 701, 3225, 3150, 3224, 6274, 6911, 7955,
+5088, 230, 953, 954, 798, 5606, 2275, 5604, 6999, 2271, 2273,
+5089, 1309, 1345, 1330, 732, 1747, 1682, 1748, 6500, 7935, 6499,
+5090, 1361, 753, 779, 766, 7737, 5484, 7832, 7833, 5422, 5478,
+5091, 17, 157, 795, 158, 3568, 1791, 6231, 3567, 1393, 1792,
+5092, 465, 464, 1034, 354, 4398, 7707, 7708, 4397, 4394, 7528,
+5093, 572, 1092, 483, 376, 7555, 7397, 4751, 4752, 7609, 4498,
+5094, 758, 1334, 1329, 1300, 6972, 1709, 7945, 6814, 3124, 3125,
+5095, 743, 1334, 758, 1300, 6974, 6972, 5389, 6815, 3124, 6814,
+5096, 771, 1367, 1370, 1366, 6537, 1612, 7674, 6414, 1611, 1607,
+5097, 12, 13, 152, 790, 1505, 3559, 3556, 7795, 5693, 1776,
+5098, 1263, 666, 1288, 597, 6359, 6746, 1745, 7785, 5100, 6745,
+5099, 698, 1331, 1313, 721, 6582, 3202, 6581, 5249, 6554, 6552,
+5100, 1051, 896, 363, 895, 2558, 7316, 6419, 2557, 2059, 7798,
+5101, 669, 1281, 1316, 1282, 6049, 3502, 7738, 6048, 3426, 3113,
+5102, 18, 17, 229, 159, 1510, 3687, 3686, 3571, 3569, 6593,
+5103, 792, 369, 227, 334, 6791, 4118, 6790, 7083, 4117, 4047,
+5104, 1304, 1292, 670, 1315, 3491, 6056, 7128, 1740, 3533, 6055,
+5105, 1022, 312, 866, 867, 6090, 7956, 2470, 2471, 6399, 1972,
+5106, 1319, 1358, 760, 1334, 1711, 6465, 6464, 1712, 1674, 6973,
+5107, 483, 376, 961, 233, 4498, 5602, 7396, 4452, 4131, 7811,
+5108, 1266, 654, 1264, 1315, 6251, 7228, 3374, 3269, 7233, 3532,
+5109, 484, 808, 964, 809, 7141, 2303, 7006, 6318, 1835, 2304,
+5110, 391, 973, 975, 244, 7391, 2336, 7957, 4169, 6214, 6212,
+5111, 339, 233, 25, 805, 4080, 3695, 3983, 5496, 7952, 7885,
+5112, 697, 1323, 1316, 1281, 5672, 3476, 5670, 6357, 3204, 3502,
+5113, 1100, 499, 1184, 500, 7958, 5682, 3024, 7517, 4523, 6843,
+5114, 791, 13, 227, 333, 5692, 3683, 6101, 7687, 3971, 4099,
+5115, 1112, 1171, 706, 1236, 2988, 7959, 5754, 3250, 3249, 5755,
+5116, 723, 729, 1323, 697, 5313, 5928, 5673, 5320, 5386, 5672,
+5117, 1042, 486, 1143, 469, 7936, 7960, 2879, 6029, 4469, 6014,
+5118, 1340, 1270, 745, 1289, 3208, 6811, 5970, 3193, 3207, 7924,
+5119, 782, 6, 330, 223, 6793, 3965, 5854, 5855, 3674, 3999,
+5120, 469, 322, 1042, 486, 4410, 7879, 6029, 4469, 4468, 7936,
+5121, 625, 512, 1174, 590, 4931, 6458, 7524, 4933, 4822, 6457,
+5122, 1252, 709, 1186, 708, 6248, 6151, 3325, 6071, 5213, 6070,
+5123, 782, 223, 1013, 781, 5855, 5850, 2444, 1754, 6046, 2443,
+5124, 697, 1281, 1316, 669, 6357, 3502, 5670, 5250, 6049, 7738,
+5125, 1143, 557, 469, 486, 6886, 4694, 6014, 7960, 4696, 4469,
+5126, 1144, 486, 602, 557, 7354, 4859, 7401, 7403, 4696, 4860,
+5127, 308, 1015, 452, 344, 6558, 5534, 4355, 3997, 5836, 4354,
+5128, 232, 482, 375, 959, 4448, 4465, 4130, 7961, 6165, 5523,
+5129, 661, 645, 682, 1298, 5068, 5126, 5128, 6723, 6724, 6786,
+5130, 1303, 675, 657, 1302, 7962, 5103, 7940, 3531, 5988, 7752,
+5131, 451, 380, 1119, 1018, 4352, 5954, 5952, 7569, 7097, 2807,
+5132, 295, 930, 440, 1003, 7462, 7754, 4317, 7914, 2627, 7498,
+5133, 50, 195, 194, 351, 6626, 1431, 7330, 4014, 6624, 7632,
+5134, 366, 575, 1075, 563, 4760, 5892, 7963, 4715, 4761, 5931,
+5135, 1163, 974, 1100, 500, 2960, 2748, 2961, 6023, 6024, 7517,
+5136, 309, 1017, 380, 346, 7212, 7096, 4140, 4056, 7964, 4139,
+5137, 368, 1078, 946, 945, 5585, 2673, 7965, 5744, 2672, 2251,
+5138, 370, 1126, 459, 1025, 7648, 7319, 4380, 7966, 2828, 7530,
+5139, 945, 790, 946, 333, 2247, 2249, 2251, 7967, 7686, 7968,
+5140, 1286, 722, 714, 687, 7844, 5255, 7843, 6069, 5254, 5225,
+5141, 441, 849, 931, 1006, 6908, 2184, 5564, 6224, 2425, 2424,
+5142, 368, 945, 946, 333, 5744, 2251, 7965, 4115, 7967, 7968,
+5143, 757, 1350, 1362, 1347, 6436, 1643, 6933, 6556, 1669, 1670,
+5144, 946, 333, 227, 477, 7968, 4099, 6099, 7917, 4431, 4430,
+5145, 208, 885, 207, 62, 2025, 2024, 1444, 7623, 7281, 7622,
+5146, 987, 913, 264, 988, 2369, 6712, 7185, 2597, 2372, 6898,
+5147, 946, 333, 791, 227, 7968, 7687, 2250, 6099, 4099, 6101,
+5148, 414, 413, 1055, 520, 4240, 5858, 5857, 4588, 4586, 7725,
+5149, 987, 517, 409, 1060, 5592, 4576, 5885, 2647, 5593, 5814,
+5150, 411, 987, 264, 988, 7969, 7185, 4229, 6892, 2597, 6898,
+5151, 264, 410, 263, 830, 4227, 4226, 3787, 6935, 5922, 5691,
+5152, 791, 333, 946, 790, 7687, 7968, 2250, 1781, 7686, 2249,
+5153, 1118, 453, 380, 599, 7970, 4361, 7860, 7675, 4851, 4850,
+5154, 1263, 1203, 1204, 554, 3360, 3095, 3361, 7971, 7662, 7734,
+5155, 56, 354, 879, 878, 4020, 7529, 7895, 7839, 7527, 2008,
+5156, 527, 1162, 526, 421, 6307, 5721, 4610, 4608, 6063, 4606,
+5157, 248, 1058, 978, 905, 6755, 2587, 7954, 6463, 2586, 2345,
+5158, 260, 57, 202, 828, 3773, 6242, 5550, 6103, 6328, 1881,
+5159, 991, 1110, 417, 1103, 2774, 5935, 7621, 2755, 2775, 6600,
+5160, 1276, 607, 1211, 662, 5994, 6198, 3403, 7791, 5071, 6200,
+5161, 837, 277, 424, 278, 7221, 4268, 6332, 7872, 3829, 4269,
+5162, 935, 137, 304, 854, 2146, 7972, 6125, 2216, 1936, 6126,
+5163, 363, 326, 474, 1051, 4073, 4423, 4422, 6419, 7262, 6418,
+5164, 942, 563, 382, 366, 7973, 4716, 7112, 5887, 4715, 4145,
+5165, 467, 1038, 356, 1037, 7547, 7913, 4404, 7907, 2520, 7235,
+5166, 571, 1091, 572, 376, 7975, 7974, 4794, 4747, 7610, 4752,
+5167, 260, 828, 202, 911, 6103, 1881, 5550, 5551, 2166, 2095,
+5168, 218, 217, 836, 72, 1454, 1898, 1897, 7198, 5537, 6669,
+5169, 491, 1047, 1046, 1148, 7976, 2547, 7756, 6728, 2894, 2893,
+5170, 419, 917, 273, 835, 7977, 7848, 4254, 7762, 2204, 7340,
+5171, 1, 1375, 142, 3, 7187, 7856, 3672, 3606, 6763, 1496,
+5172, 613, 1195, 1098, 632, 7537, 3057, 6501, 4954, 6182, 6503,
+5173, 1192, 706, 747, 707, 5799, 5343, 5938, 5800, 5206, 5344,
+5174, 854, 137, 304, 138, 1936, 7972, 6126, 1935, 1491, 7694,
+5175, 856, 106, 141, 105, 7817, 3670, 1940, 7925, 1555, 3669,
+5176, 490, 1039, 320, 1038, 7564, 7911, 4484, 7546, 2523, 7910,
+5177, 936, 854, 304, 138, 2189, 6126, 7705, 2149, 1935, 7694,
+5178, 295, 93, 94, 930, 3878, 1543, 3879, 7462, 7463, 6961,
+5179, 428, 841, 923, 996, 5711, 2176, 5764, 7819, 2394, 2393,
+5180, 1226, 498, 1123, 1124, 6810, 6403, 3203, 3206, 6404, 2823,
+5181, 139, 103, 305, 104, 3665, 3908, 7978, 3666, 1553, 3909,
+5182, 1056, 973, 392, 904, 2577, 7453, 7384, 2576, 2340, 7642,
+5183, 769, 750, 1321, 1348, 5430, 7258, 7908, 7672, 6614, 1722,
+5184, 56, 354, 318, 879, 4020, 4088, 3937, 7895, 7529, 7651,
+5185, 121, 90, 89, 291, 3634, 1539, 3633, 7027, 3867, 3866,
+5186, 452, 1016, 1117, 453, 5533, 2802, 5532, 4360, 7824, 7800,
+5187, 924, 842, 285, 114, 2177, 7157, 6771, 2124, 1911, 6168,
+5188, 698, 1272, 1307, 1317, 5777, 3366, 5775, 6583, 3368, 3367,
+5189, 897, 327, 364, 1053, 7306, 4074, 5841, 2563, 5635, 5636,
+5190, 834, 916, 271, 68, 2203, 7218, 6210, 6271, 6197, 3806,
+5191, 64, 322, 886, 358, 3945, 6190, 6186, 4028, 4092, 6187,
+5192, 305, 104, 855, 139, 3909, 6945, 7979, 7978, 3666, 1938,
+5193, 917, 273, 1376, 70, 7848, 7024, 6962, 7067, 3812, 7026,
+5194, 1017, 453, 1118, 1016, 7213, 7970, 2804, 2457, 7824, 2803,
+5195, 450, 1011, 385, 1158, 7101, 7541, 4462, 6574, 2929, 7596,
+5196, 139, 138, 936, 103, 1492, 2149, 2148, 3665, 3664, 7980,
+5197, 1117, 1016, 1118, 453, 2802, 2803, 2805, 7800, 7824, 7970,
+5198, 1295, 1280, 1281, 697, 3422, 3445, 3205, 7456, 6356, 6357,
+5199, 309, 453, 1017, 1016, 4358, 7213, 7212, 7518, 7824, 2457,
+5200, 1101, 1105, 517, 1060, 2762, 6707, 5591, 2751, 2759, 5593,
+5201, 405, 985, 406, 1106, 6109, 6110, 4216, 6644, 2763, 6396,
+5202, 936, 138, 304, 103, 2149, 7694, 7705, 7980, 3664, 3906,
+5203, 56, 202, 828, 201, 7495, 1881, 6330, 6331, 1438, 1882,
+5204, 1189, 613, 1098, 532, 6547, 6501, 2972, 5983, 4949, 5982,
+5205, 287, 116, 86, 117, 6959, 3625, 3855, 7946, 1470, 3626,
+5206, 86, 116, 287, 85, 3625, 6959, 3855, 1535, 3624, 3854,
+5207, 305, 855, 936, 139, 7979, 2217, 7189, 7978, 1938, 2148,
+5208, 380, 453, 1118, 1017, 4361, 7970, 7860, 7096, 7213, 2804,
+5209, 99, 300, 98, 933, 3894, 3893, 1548, 6887, 7479, 7950,
+5210, 1263, 1203, 554, 597, 3360, 7662, 7971, 7785, 7786, 4844,
+5211, 1167, 445, 1008, 545, 5734, 7173, 2958, 6252, 4665, 7583,
+5212, 99, 98, 132, 933, 1548, 3653, 3654, 6887, 7950, 2143,
+5213, 1220, 640, 1164, 1168, 6370, 7981, 3167, 3168, 6520, 2964,
+5214, 127, 849, 296, 930, 1926, 6909, 6910, 2136, 2211, 7747,
+5215, 735, 1323, 1330, 729, 5927, 1699, 7982, 5315, 5928, 6498,
+5216, 1221, 525, 526, 1108, 7150, 4607, 7983, 3179, 7358, 5719,
+5217, 10, 332, 787, 225, 3969, 7984, 7080, 3678, 4045, 7081,
+5218, 122, 123, 292, 928, 1476, 7709, 7355, 2133, 2132, 7711,
+5219, 1221, 1108, 526, 1190, 3179, 5719, 7983, 3182, 3043, 5720,
+5220, 563, 940, 382, 478, 5645, 7406, 4716, 4781, 5773, 4438,
+5221, 17, 158, 795, 796, 3567, 1792, 6231, 7985, 1794, 1796,
+5222, 902, 977, 242, 974, 2342, 6888, 7034, 2332, 2343, 5677,
+5223, 1288, 666, 667, 597, 6746, 5101, 6743, 6745, 5100, 5081,
+5224, 940, 563, 1073, 478, 5645, 5644, 2657, 5773, 4781, 7644,
+5225, 331, 786, 148, 785, 7089, 1764, 7394, 5669, 1766, 1762,
+5226, 229, 796, 952, 797, 7918, 2267, 6741, 6592, 1799, 2268,
+5227, 18, 797, 229, 336, 6591, 6592, 3686, 3978, 7065, 4049,
+5228, 1221, 1190, 526, 631, 3182, 5720, 7983, 7151, 6054, 4835,
+5229, 967, 235, 485, 378, 6038, 4458, 7337, 7022, 4135, 4496,
+5230, 584, 1096, 485, 967, 5648, 6202, 4801, 5647, 2737, 7337,
+5231, 340, 963, 483, 377, 7613, 7139, 4451, 4134, 7140, 4501,
+5232, 485, 812, 342, 235, 7986, 6722, 4457, 4458, 7300, 4055,
+5233, 549, 372, 496, 1083, 4678, 4724, 4725, 6337, 7416, 6339,
+5234, 259, 828, 56, 57, 6327, 6330, 3770, 3771, 6328, 1580,
+5235, 466, 1036, 355, 487, 7352, 5504, 4401, 4473, 5506, 4471,
+5236, 1197, 498, 1226, 1124, 6009, 6810, 3258, 3065, 6404, 3206,
+5237, 1313, 684, 668, 1267, 7731, 5133, 6551, 1733, 7733, 6490,
+5238, 27, 26, 340, 170, 1519, 3986, 3985, 3591, 3589, 7987,
+5239, 985, 406, 260, 259, 6110, 4215, 6102, 6111, 4214, 3775,
+5240, 550, 604, 1231, 487, 4869, 7808, 7134, 4783, 4866, 7579,
+5241, 1074, 940, 941, 563, 2658, 2236, 2659, 5646, 5645, 7407,
+5242, 395, 394, 1156, 505, 4183, 6174, 7815, 4538, 4537, 6172,
+5243, 921, 79, 108, 280, 7749, 3610, 2115, 6636, 3835, 6635,
+5244, 293, 92, 294, 929, 3873, 3875, 3877, 7374, 6938, 6937,
+5245, 1158, 997, 387, 1100, 2931, 7593, 7591, 2943, 2786, 7688,
+5246, 942, 563, 1074, 941, 7973, 5646, 2661, 2239, 7407, 2659,
+5247, 1358, 1334, 780, 760, 1674, 6521, 6405, 6465, 6973, 5487,
+5248, 636, 635, 538, 1171, 4966, 4962, 4964, 6762, 6305, 6312,
+5249, 1011, 855, 306, 937, 2436, 6430, 7103, 2435, 2190, 6429,
+5250, 63, 885, 208, 62, 7291, 2025, 7722, 1586, 7281, 7623,
+5251, 690, 740, 1299, 674, 5186, 7409, 7680, 5160, 5220, 7410,
+5252, 356, 466, 467, 1037, 4402, 4477, 4404, 7235, 7236, 7907,
+5253, 847, 292, 437, 293, 7710, 4308, 6838, 7381, 3874, 4309,
+5254, 539, 1171, 1000, 1170, 7594, 2978, 7087, 7131, 2987, 2976,
+5255, 1017, 861, 309, 1016, 2455, 6145, 7212, 2457, 2453, 7518,
+5256, 746, 1173, 705, 1236, 5853, 7845, 5309, 5557, 3251, 5757,
+5257, 1266, 654, 617, 1264, 6251, 5039, 6250, 3374, 7228, 7227,
+5258, 110, 840, 282, 80, 1907, 7166, 7164, 3613, 7390, 3839,
+5259, 110, 80, 282, 81, 3613, 3839, 7164, 3614, 1530, 3840,
+5260, 281, 80, 282, 840, 3837, 3839, 3841, 5696, 7390, 7166,
+5261, 109, 840, 110, 80, 1908, 1907, 1463, 3612, 7390, 3613,
+5262, 293, 929, 847, 124, 7374, 2182, 7381, 7789, 2135, 1921,
+5263, 550, 487, 1231, 1137, 4783, 7579, 7134, 7135, 7299, 3226,
+5264, 1329, 1334, 780, 1359, 1709, 6521, 7287, 1677, 1675, 6406,
+5265, 829, 912, 1373, 262, 2167, 6376, 7878, 7772, 7425, 7424,
+5266, 55, 877, 878, 200, 7988, 2005, 7840, 7841, 2001, 2003,
+5267, 192, 823, 46, 191, 1871, 6461, 7989, 1428, 1872, 7990,
+5268, 853, 302, 303, 101, 7992, 3904, 7991, 7180, 3900, 3902,
+5269, 582, 498, 1122, 1226, 4855, 7601, 7838, 6809, 6810, 3064,
+5270, 43, 311, 866, 865, 3922, 7682, 5587, 5780, 7292, 1969,
+5271, 1122, 498, 1123, 1226, 7601, 6403, 2820, 3064, 6810, 3203,
+5272, 1358, 760, 780, 775, 6465, 5487, 6405, 6268, 5457, 5491,
+5273, 1303, 1302, 1321, 675, 3531, 3521, 1736, 7962, 5988, 5987,
+5274, 1033, 464, 1134, 489, 7691, 6535, 2852, 7329, 4482, 5958,
+5275, 985, 911, 260, 1057, 2365, 5551, 6102, 2582, 2581, 7993,
+5276, 1134, 564, 1133, 489, 7637, 6965, 2853, 5958, 4717, 5947,
+5277, 260, 829, 203, 58, 6760, 1884, 5552, 3774, 7994, 6171,
+5278, 835, 215, 1376, 216, 1896, 6963, 6964, 1895, 1452, 7070,
+5279, 213, 916, 67, 212, 2104, 6195, 7995, 1449, 2105, 6801,
+5280, 685, 1290, 650, 618, 7741, 7684, 5135, 5136, 7929, 5017,
+5281, 303, 136, 853, 101, 7696, 1933, 7991, 3902, 3660, 7180,
+5282, 293, 123, 91, 124, 7788, 3637, 3872, 7789, 1477, 3638,
+5283, 472, 1149, 1150, 1048, 7433, 2901, 7581, 6675, 2897, 2899,
+5284, 382, 563, 942, 941, 4716, 7973, 7112, 7098, 7407, 2239,
+5285, 537, 435, 1054, 1065, 4639, 7175, 7368, 6420, 6421, 2615,
+5286, 789, 788, 151, 226, 1775, 1771, 1773, 7082, 6030, 7996,
+5287, 86, 117, 118, 288, 3626, 1471, 3627, 3857, 7562, 7876,
+5288, 151, 788, 11, 226, 1771, 7668, 3554, 7996, 6030, 3681,
+5289, 1112, 1054, 537, 635, 2782, 7368, 7467, 5926, 6304, 4961,
+5290, 55, 354, 56, 878, 4021, 4020, 1579, 7840, 7527, 7839,
+5291, 923, 112, 284, 113, 2122, 7293, 5765, 2121, 1466, 7774,
+5292, 331, 940, 941, 785, 5772, 2236, 7099, 5669, 2232, 2234,
+5293, 957, 956, 562, 1087, 2284, 6917, 6129, 2706, 2705, 6131,
+5294, 11, 226, 788, 332, 3681, 6030, 7668, 3968, 3970, 6031,
+5295, 1077, 1076, 573, 1208, 2671, 7998, 7997, 3109, 3108, 7999,
+5296, 294, 92, 93, 125, 3875, 1542, 3876, 6939, 3640, 3641,
+5297, 718, 662, 1291, 1278, 5238, 7727, 7560, 7001, 7728, 3260,
+5298, 450, 343, 385, 1011, 4440, 4357, 4462, 7101, 7102, 7541,
+5299, 1089, 494, 649, 1088, 7229, 5014, 6136, 2713, 7334, 6137,
+5300, 649, 494, 562, 1088, 5014, 4713, 5011, 6137, 7334, 6130,
+5301, 958, 1088, 374, 494, 2709, 7267, 6000, 6002, 7334, 4509,
+5302, 374, 1088, 562, 494, 7267, 6130, 4711, 4509, 7334, 4713,
+5303, 294, 93, 848, 125, 3876, 7465, 7370, 6939, 3641, 1924,
+5304, 713, 1333, 766, 740, 7048, 7049, 5420, 5359, 8000, 5419,
+5305, 1364, 774, 737, 772, 6485, 5448, 6480, 6482, 5451, 5439,
+5306, 657, 1303, 715, 675, 7940, 5867, 5226, 5103, 7962, 5228,
+5307, 1326, 1325, 759, 1291, 3270, 7142, 5981, 2689, 3495, 6444,
+5308, 1219, 522, 594, 523, 6239, 4831, 6347, 7702, 4597, 4832,
+5309, 238, 817, 237, 35, 6189, 5824, 3709, 3707, 5825, 3706,
+5310, 418, 417, 991, 1110, 4252, 7621, 5918, 5919, 5935, 2774,
+5311, 900, 36, 181, 35, 5569, 7568, 2072, 6188, 1559, 8001,
+5312, 293, 92, 929, 124, 3873, 6938, 7374, 7789, 3639, 2135,
+5313, 1299, 1333, 1277, 740, 3141, 2698, 3397, 7409, 8000, 7408,
+5314, 507, 1107, 397, 508, 6016, 6511, 4544, 4548, 6017, 4546,
+5315, 1075, 563, 942, 366, 5931, 7973, 2663, 7963, 4715, 5887,
+5316, 582, 1226, 1121, 1225, 6809, 3063, 6215, 6194, 3256, 3200,
+5317, 460, 530, 457, 1124, 4619, 4618, 4384, 5634, 6729, 8002,
+5318, 1227, 1127, 1198, 566, 3212, 3211, 3215, 6708, 7630, 6703,
+5319, 825, 908, 196, 51, 2163, 2089, 1875, 7804, 8003, 7803,
+5320, 50, 351, 194, 49, 4014, 7632, 7330, 1573, 4015, 7325,
+5321, 713, 1333, 1277, 1345, 7048, 2698, 7017, 7018, 1713, 2697,
+5322, 1115, 475, 1053, 454, 7616, 5637, 2796, 6756, 4463, 6061,
+5323, 1075, 575, 603, 563, 5892, 5004, 5929, 5931, 4761, 4865,
+5324, 463, 1031, 353, 316, 5796, 5500, 4392, 4393, 8004, 4063,
+5325, 943, 575, 1075, 366, 5891, 5892, 2664, 5888, 4760, 7963,
+5326, 490, 357, 320, 1039, 4486, 4067, 4484, 7564, 7549, 7911,
+5327, 478, 939, 940, 784, 7801, 2233, 5773, 5699, 2229, 2231,
+5328, 472, 491, 1148, 1047, 4492, 6728, 7431, 7432, 7976, 2894,
+5329, 1230, 564, 1134, 552, 6966, 7637, 3223, 6967, 4720, 6536,
+5330, 573, 575, 616, 1076, 4762, 5142, 4908, 7998, 5890, 7077,
+5331, 563, 603, 1205, 497, 4865, 7441, 7805, 4782, 4863, 7766,
+5332, 532, 428, 1001, 531, 4622, 7818, 6293, 4624, 4621, 6228,
+5333, 569, 1117, 1154, 1161, 6236, 2913, 5789, 6238, 3060, 2938,
+5334, 8, 146, 224, 784, 3548, 7823, 3676, 5877, 1758, 5700,
+5335, 568, 377, 493, 964, 4734, 4506, 4735, 7861, 7032, 7030,
+5336, 202, 880, 58, 203, 2009, 5596, 6170, 1439, 2010, 6171,
+5337, 1010, 1071, 449, 854, 2637, 5809, 5808, 2433, 2634, 6618,
+5338, 417, 523, 1110, 524, 4596, 6599, 5935, 4598, 4600, 5936,
+5339, 147, 146, 8, 784, 1382, 3548, 3547, 1759, 1758, 5877,
+5340, 1186, 640, 1220, 1168, 6518, 6370, 3169, 3028, 6520, 3168,
+5341, 1306, 685, 1317, 1272, 6204, 6700, 3362, 3506, 7249, 3368,
+5342, 17, 335, 229, 796, 3975, 4076, 3687, 7985, 7606, 7918,
+5343, 796, 17, 159, 229, 7985, 3569, 1795, 7918, 3687, 6593,
+5344, 1272, 685, 1317, 698, 7249, 6700, 3368, 5777, 5176, 6583,
+5345, 149, 225, 787, 786, 5575, 7081, 1767, 1765, 7090, 1769,
+5346, 17, 157, 16, 335, 3568, 3565, 1509, 3975, 6059, 3976,
+5347, 213, 212, 67, 890, 1449, 6801, 7995, 2040, 2039, 7243,
+5348, 942, 563, 1075, 1074, 7973, 5931, 2663, 2661, 5646, 2665,
+5349, 375, 804, 232, 959, 5522, 5614, 4130, 5523, 2289, 7961,
+5350, 1156, 978, 1056, 393, 2921, 2578, 2922, 7718, 7719, 7720,
+5351, 743, 1238, 1300, 755, 7896, 3478, 6815, 5377, 6944, 6813,
+5352, 1312, 702, 694, 683, 6004, 5190, 7947, 7753, 5189, 5184,
+5353, 628, 1194, 1244, 1248, 6143, 3292, 6141, 7760, 3310, 3312,
+5354, 724, 1322, 1319, 1311, 7626, 1714, 7388, 5686, 3209, 3210,
+5355, 1117, 453, 1118, 574, 7800, 7970, 2805, 6237, 4757, 7393,
+5356, 604, 1301, 657, 1268, 7903, 7930, 5055, 7871, 3481, 7941,
+5357, 426, 365, 999, 456, 4277, 5898, 7290, 4714, 4369, 7193,
+5358, 878, 201, 56, 200, 2004, 6331, 7839, 2003, 1437, 7842,
+5359, 1024, 457, 1023, 349, 6275, 5697, 2478, 5508, 4371, 5507,
+5360, 1206, 1117, 1118, 574, 3102, 2805, 3103, 5956, 6237, 7393,
+5361, 976, 388, 1100, 974, 7519, 7516, 2749, 2339, 5678, 2748,
+5362, 1275, 1274, 1208, 610, 3263, 3398, 3399, 5617, 5763, 5619,
+5363, 803, 482, 232, 959, 6164, 4448, 5651, 2288, 6165, 7961,
+5364, 753, 751, 1342, 1366, 5367, 7302, 6828, 6415, 6416, 1662,
+5365, 1078, 570, 1079, 1209, 5584, 8005, 2677, 3115, 7434, 3116,
+5366, 181, 180, 900, 35, 1417, 2073, 2072, 8001, 6180, 6188,
+5367, 1340, 1294, 745, 1270, 3261, 7640, 5970, 3208, 3535, 6811,
+5368, 779, 1366, 771, 753, 6539, 6414, 5490, 5484, 6415, 5441,
+5369, 779, 1371, 738, 1367, 6525, 6526, 5477, 6538, 1632, 7902,
+5370, 1230, 555, 1132, 564, 7324, 5973, 3074, 6966, 4719, 5974,
+5371, 1032, 876, 353, 1031, 2500, 5502, 7214, 2502, 2498, 5500,
+5372, 1139, 1038, 1140, 467, 2867, 2869, 2871, 7906, 7547, 7545,
+5373, 550, 466, 1139, 467, 4680, 7544, 7421, 4679, 4477, 7906,
+5374, 934, 302, 853, 135, 7216, 7992, 2215, 2144, 7160, 1934,
+5375, 857, 179, 180, 35, 1941, 1416, 1942, 6052, 5822, 6180,
+5376, 250, 47, 823, 249, 3743, 7040, 7042, 3745, 3741, 6751,
+5377, 1158, 1100, 387, 495, 2943, 7688, 7591, 6573, 7852, 4763,
+5378, 495, 499, 1100, 387, 4764, 7958, 7852, 4763, 4519, 7688,
+5379, 59, 829, 203, 204, 7887, 1884, 8006, 7251, 1883, 1440,
+5380, 499, 388, 1100, 387, 4520, 7516, 7958, 4519, 4162, 7688,
+5381, 976, 387, 240, 997, 6079, 4157, 6078, 2398, 7593, 6836,
+5382, 399, 981, 982, 1102, 5759, 2589, 5760, 6997, 2753, 2752,
+5383, 271, 916, 270, 68, 7218, 6196, 3808, 3806, 6197, 3804,
+5384, 595, 526, 527, 1190, 4836, 4610, 4837, 6053, 5720, 6306,
+5385, 892, 69, 361, 324, 8007, 4035, 7011, 7015, 3948, 4071,
+5386, 474, 1052, 1153, 475, 6417, 2909, 7763, 4502, 5941, 7615,
+5387, 1021, 348, 1022, 455, 7092, 7905, 2472, 6663, 4365, 5747,
+5388, 670, 654, 1315, 608, 5089, 7233, 6055, 5088, 5038, 6057,
+5389, 771, 779, 738, 1367, 5490, 5477, 5437, 6537, 6538, 7902,
+5390, 836, 72, 217, 918, 6669, 5537, 1898, 2205, 5536, 2108,
+5391, 804, 803, 232, 959, 1820, 5651, 5614, 2289, 2288, 7961,
+5392, 1204, 585, 1263, 554, 8008, 6358, 3361, 7734, 4805, 7971,
+5393, 738, 1367, 1353, 1348, 7902, 1639, 6615, 6616, 1640, 1660,
+5394, 18, 336, 19, 160, 3978, 3977, 1511, 3570, 7064, 3573,
+5395, 472, 554, 473, 1150, 4689, 4688, 4488, 7581, 7430, 7111,
+5396, 704, 685, 703, 1335, 5195, 5191, 5196, 6205, 6206, 6664,
+5397, 1353, 1367, 738, 1371, 1639, 7902, 6615, 1610, 1632, 6526,
+5398, 814, 970, 969, 425, 2321, 2323, 2319, 5612, 6818, 7050,
+5399, 966, 810, 811, 235, 2309, 1841, 2310, 6037, 7054, 6039,
+5400, 473, 1050, 362, 1049, 7266, 6692, 4419, 6608, 2556, 7551,
+5401, 966, 235, 967, 378, 6037, 6038, 2314, 7023, 4135, 7022,
+5402, 1220, 641, 1164, 640, 6369, 6261, 3167, 6370, 4981, 7981,
+5403, 1133, 1230, 1132, 564, 3075, 3074, 2850, 6965, 6966, 5974,
+5404, 810, 378, 341, 235, 7109, 4136, 7122, 7054, 4135, 4082,
+5405, 965, 810, 966, 378, 2307, 2309, 2311, 6294, 7109, 7023,
+5406, 399, 1102, 398, 981, 6997, 6990, 4195, 5759, 2753, 7922,
+5407, 1254, 588, 1253, 1239, 7690, 7125, 3333, 3331, 8009, 3328,
+5408, 985, 1057, 260, 406, 2582, 7993, 6102, 6110, 6395, 4215,
+5409, 364, 898, 1013, 328, 5842, 2445, 6060, 4098, 5845, 5849,
+5410, 718, 1278, 1291, 1279, 7001, 3260, 7560, 7004, 3443, 3454,
+5411, 367, 1115, 1073, 939, 6753, 2795, 7646, 6752, 2794, 2656,
+5412, 1242, 1238, 683, 624, 3286, 6863, 7859, 7480, 6848, 5129,
+5413, 651, 662, 716, 1278, 5070, 5236, 5233, 7740, 7728, 7002,
+5414, 265, 831, 63, 266, 7575, 8010, 3789, 3793, 8011, 3791,
+5415, 690, 699, 1299, 740, 5181, 7661, 7680, 5186, 5185, 7409,
+5416, 594, 696, 593, 1258, 5149, 5148, 4833, 6346, 6341, 7521,
+5417, 914, 267, 209, 64, 5548, 6671, 2100, 5581, 3794, 7670,
+5418, 742, 1356, 1319, 1322, 6957, 1710, 6466, 8012, 1688, 1714,
+5419, 1332, 1341, 682, 733, 1732, 6787, 5869, 7184, 7548, 5303,
+5420, 1042, 886, 887, 322, 2530, 2032, 2531, 7879, 6190, 6191,
+5421, 986, 829, 260, 261, 2366, 6760, 6807, 6949, 8013, 3778,
+5422, 373, 799, 230, 954, 7671, 6996, 4126, 5620, 2274, 5604,
+5423, 815, 970, 425, 971, 2322, 6818, 6978, 2324, 2327, 6819,
+5424, 815, 970, 814, 425, 2322, 2321, 1853, 6978, 6818, 5612,
+5425, 1144, 486, 1145, 576, 7354, 6432, 2886, 5599, 4769, 5598,
+5426, 958, 959, 1089, 494, 2290, 2712, 2711, 6002, 5531, 7229,
+5427, 1077, 570, 573, 368, 7188, 4756, 7997, 5743, 4742, 4754,
+5428, 1125, 530, 1197, 1124, 8014, 5656, 3066, 2826, 6729, 3065,
+5429, 409, 1060, 986, 912, 5814, 2595, 8015, 8016, 2594, 2368,
+5430, 777, 763, 1329, 1338, 5467, 6611, 7288, 6492, 6612, 1676,
+5431, 912, 1060, 830, 409, 2594, 2596, 2199, 8016, 5814, 5886,
+5432, 1364, 1352, 737, 1349, 1615, 6481, 6480, 1623, 1633, 7470,
+5433, 737, 769, 715, 1352, 5434, 5431, 5318, 6481, 6472, 8017,
+5434, 715, 769, 1321, 1352, 5431, 7908, 7257, 8017, 6472, 1723,
+5435, 715, 1352, 1332, 737, 8017, 1721, 5868, 5318, 6481, 7183,
+5436, 1321, 1352, 1332, 715, 1723, 1721, 1724, 7257, 8017, 5868,
+5437, 494, 482, 958, 959, 4508, 6001, 6002, 5531, 6165, 2290,
+5438, 228, 334, 793, 15, 4075, 6385, 6409, 3685, 3973, 6410,
+5439, 767, 1360, 736, 1371, 6367, 5978, 5425, 6527, 1645, 6667,
+5440, 1312, 1242, 694, 1311, 3527, 6104, 7947, 3529, 3519, 5985,
+5441, 334, 948, 369, 476, 6386, 6438, 4117, 4427, 5771, 4428,
+5442, 769, 1348, 1321, 1352, 7672, 1722, 7908, 6472, 1647, 1723,
+5443, 1112, 635, 706, 1171, 5926, 5202, 5754, 2988, 6305, 7959,
+5444, 1189, 644, 1196, 1195, 6548, 6082, 3314, 3058, 7055, 3313,
+5445, 824, 907, 252, 981, 2162, 6761, 7332, 2352, 2351, 6721,
+5446, 1156, 394, 395, 1058, 6174, 4183, 7815, 3010, 7665, 7013,
+5447, 1156, 504, 1222, 1239, 6173, 6587, 3190, 3302, 6314, 3303,
+5448, 980, 508, 1107, 1102, 6510, 6017, 2766, 2754, 6991, 2927,
+5449, 1095, 596, 568, 584, 7084, 4905, 5639, 5649, 4842, 4877,
+5450, 1095, 596, 1218, 1094, 7084, 6496, 3161, 2734, 5527, 3160,
+5451, 1254, 1239, 1188, 620, 3331, 3322, 3332, 6850, 8018, 7587,
+5452, 539, 1000, 538, 437, 7087, 7373, 4647, 4645, 6837, 4644,
+5453, 1188, 1239, 1222, 620, 3322, 3303, 3288, 7587, 8018, 7706,
+5454, 1254, 1269, 672, 587, 3390, 7585, 6849, 6035, 6036, 5093,
+5455, 243, 390, 975, 244, 4166, 6085, 6528, 3727, 4167, 6212,
+5456, 945, 226, 789, 333, 8019, 7082, 2246, 7967, 4046, 7797,
+5457, 672, 710, 679, 1256, 5311, 5356, 5252, 7612, 7277, 6853,
+5458, 1222, 1239, 504, 620, 3303, 6314, 6587, 7706, 8018, 4919,
+5459, 330, 367, 224, 783, 4114, 4113, 3992, 5971, 6882, 6988,
+5460, 955, 800, 956, 481, 2277, 2279, 2281, 5624, 5873, 5623,
+5461, 481, 800, 231, 337, 5873, 5871, 4446, 4447, 5966, 4078,
+5462, 655, 632, 633, 1191, 5047, 4957, 5111, 7865, 6184, 6798,
+5463, 399, 398, 252, 981, 4195, 4191, 4193, 5759, 7922, 6721,
+5464, 150, 149, 10, 787, 1385, 3553, 3552, 1768, 1767, 7080,
+5465, 980, 981, 251, 398, 2353, 8020, 7058, 7826, 7922, 4190,
+5466, 397, 1107, 507, 979, 6511, 6016, 4544, 6544, 2767, 7620,
+5467, 39, 38, 184, 819, 1562, 5924, 7514, 7146, 5925, 1863,
+5468, 187, 42, 188, 865, 7209, 5779, 1424, 1964, 5781, 1965,
+5469, 253, 981, 825, 982, 5758, 2354, 6719, 5761, 2589, 2356,
+5470, 985, 1106, 405, 984, 2763, 6644, 6109, 2364, 2764, 6118,
+5471, 1244, 1260, 629, 674, 3347, 5590, 7654, 7679, 5563, 5146,
+5472, 1227, 530, 1197, 1125, 5609, 5656, 3069, 3067, 8014, 3066,
+5473, 308, 1015, 344, 860, 6558, 5836, 3997, 5803, 2450, 6468,
+5474, 451, 582, 384, 1120, 4767, 4766, 4353, 5942, 5943, 7584,
+5475, 243, 975, 977, 820, 6528, 2344, 6861, 6154, 2335, 2341,
+5476, 617, 1257, 646, 656, 6629, 6630, 5024, 5051, 6175, 5052,
+5477, 647, 579, 1199, 555, 5000, 6747, 6559, 4999, 4786, 7323,
+5478, 582, 1121, 384, 1120, 6215, 5949, 4766, 5943, 2814, 7584,
+5479, 980, 981, 824, 251, 2353, 2352, 2349, 7058, 8020, 7008,
+5480, 193, 906, 47, 192, 2084, 7041, 7260, 1429, 2085, 7259,
+5481, 194, 48, 824, 49, 6584, 7009, 1873, 7325, 1572, 7010,
+5482, 193, 906, 824, 48, 2084, 2193, 1874, 6585, 7953, 7009,
+5483, 251, 981, 252, 398, 8020, 6721, 3751, 4190, 7922, 4191,
+5484, 75, 277, 837, 278, 3825, 7221, 7121, 3827, 3829, 7872,
+5485, 824, 981, 252, 251, 2352, 6721, 7332, 7008, 8020, 3751,
+5486, 375, 376, 339, 960, 4450, 4132, 4129, 5524, 5601, 5494,
+5487, 1229, 553, 1301, 600, 7933, 7932, 3496, 7868, 4852, 7869,
+5488, 1243, 521, 593, 522, 6638, 4829, 6637, 6155, 4594, 4830,
+5489, 265, 988, 989, 412, 6897, 2375, 5578, 4232, 6893, 5580,
+5490, 1109, 1182, 1055, 520, 3018, 3017, 2772, 6362, 6363, 7725,
+5491, 693, 1238, 692, 623, 6862, 8021, 5262, 5166, 6847, 5163,
+5492, 210, 267, 65, 64, 6672, 3795, 6795, 7669, 3794, 1588,
+5493, 910, 257, 404, 258, 5975, 4208, 5498, 6373, 3769, 4209,
+5494, 1101, 1160, 518, 1194, 2959, 5828, 5826, 3055, 3054, 6135,
+5495, 413, 266, 914, 989, 4235, 5582, 5546, 7402, 5579, 2373,
+5496, 1109, 413, 989, 412, 7724, 7402, 2770, 6522, 4237, 5580,
+5497, 418, 992, 991, 834, 5920, 2602, 5918, 7866, 2383, 2380,
+5498, 1244, 674, 629, 592, 7679, 5146, 7654, 7655, 5098, 4942,
+5499, 603, 585, 616, 1207, 4901, 5032, 5031, 6220, 5906, 5554,
+5500, 1144, 486, 1143, 1042, 7354, 7960, 2883, 2881, 7936, 2879,
+5501, 605, 602, 1307, 677, 4872, 7447, 6770, 5108, 5107, 7253,
+5502, 26, 233, 807, 806, 3694, 8022, 6139, 6132, 7813, 1829,
+5503, 276, 277, 423, 994, 3826, 4266, 4265, 7912, 7154, 6689,
+5504, 778, 1366, 1363, 751, 7794, 1606, 7426, 5470, 6416, 7744,
+5505, 342, 236, 813, 379, 4083, 7850, 5916, 4138, 4137, 5917,
+5506, 342, 968, 485, 379, 5915, 5811, 4457, 4138, 5812, 4497,
+5507, 1162, 422, 527, 1159, 6066, 4609, 6307, 2971, 6688, 6923,
+5508, 221, 278, 76, 75, 6860, 3828, 6859, 7729, 3827, 1599,
+5509, 1178, 653, 649, 1213, 6360, 5035, 5907, 3139, 5831, 6138,
+5510, 419, 992, 272, 917, 7617, 8023, 4253, 7977, 2382, 6985,
+5511, 54, 877, 55, 200, 7712, 7988, 1578, 6769, 2001, 7841,
+5512, 419, 992, 418, 272, 7617, 5920, 4255, 4253, 8023, 4251,
+5513, 1066, 433, 1002, 434, 5815, 5816, 2619, 7341, 4301, 8024,
+5514, 166, 232, 23, 24, 5650, 3693, 3581, 3584, 3692, 1516,
+5515, 276, 919, 837, 994, 6026, 2206, 7847, 7912, 2389, 2388,
+5516, 72, 71, 216, 918, 1595, 5674, 5535, 5536, 7338, 2109,
+5517, 1065, 536, 537, 434, 7476, 4640, 6420, 6422, 4637, 4638,
+5518, 55, 877, 54, 317, 7988, 7712, 1578, 3934, 7493, 3935,
+5519, 1156, 1180, 506, 505, 3016, 6767, 6765, 6172, 6093, 4542,
+5520, 1002, 433, 432, 536, 5816, 4298, 5837, 5838, 4635, 4634,
+5521, 925, 1064, 844, 432, 2612, 2611, 2208, 5876, 5839, 7473,
+5522, 979, 1180, 506, 1058, 3009, 6767, 6919, 2588, 3012, 6766,
+5523, 87, 288, 86, 118, 3858, 3857, 1536, 3628, 7876, 3627,
+5524, 45, 312, 868, 867, 3924, 7590, 6772, 6398, 6399, 1975,
+5525, 485, 1096, 968, 967, 6202, 2738, 5811, 7337, 2737, 2317,
+5526, 748, 747, 1255, 761, 5345, 5937, 7378, 5400, 5424, 6296,
+5527, 536, 434, 1002, 433, 4637, 8024, 5838, 4635, 4301, 5816,
+5528, 121, 291, 89, 290, 7027, 3866, 3633, 6858, 3868, 3864,
+5529, 89, 120, 121, 290, 3632, 1474, 3633, 3864, 6833, 6858,
+5530, 567, 530, 1227, 1125, 4765, 5609, 5608, 7649, 8014, 3067,
+5531, 925, 844, 288, 432, 2208, 7563, 7561, 5876, 7473, 4294,
+5532, 457, 530, 370, 1125, 4618, 4676, 4373, 6276, 8014, 6738,
+5533, 1248, 673, 591, 1224, 8025, 5096, 6975, 3311, 6316, 6976,
+5534, 1330, 1357, 756, 1345, 1679, 6283, 7938, 1682, 1683, 7934,
+5535, 444, 851, 1067, 443, 5767, 2623, 7777, 4331, 6895, 8026,
+5536, 1242, 624, 683, 590, 7480, 5129, 7859, 7481, 5058, 5130,
+5537, 1067, 443, 1007, 544, 8026, 7174, 2622, 7778, 4661, 7867,
+5538, 54, 877, 353, 317, 7712, 7492, 4018, 3935, 7493, 4087,
+5539, 738, 1355, 1353, 1371, 6666, 1609, 6615, 6526, 1608, 1610,
+5540, 360, 324, 1046, 491, 4094, 6640, 6643, 4489, 4491, 7756,
+5541, 945, 226, 944, 789, 8019, 6221, 2248, 2246, 7082, 2244,
+5542, 99, 300, 933, 301, 3894, 7479, 6887, 3896, 3898, 7851,
+5543, 1067, 851, 932, 443, 2623, 2213, 2621, 8026, 6895, 5741,
+5544, 1067, 443, 932, 1007, 8026, 5741, 2621, 2622, 7174, 2426,
+5545, 272, 992, 834, 917, 8023, 2383, 6209, 6985, 2382, 2172,
+5546, 1264, 608, 1197, 1292, 6011, 6012, 3363, 3517, 6058, 3455,
+5547, 1351, 773, 1318, 1327, 6440, 7897, 1727, 1729, 6439, 1730,
+5548, 418, 992, 834, 272, 5920, 2383, 7866, 4251, 8023, 6209,
+5549, 1318, 773, 1351, 776, 7897, 6440, 1727, 7663, 5460, 7312,
+5550, 684, 1307, 605, 1267, 7732, 6770, 5131, 7733, 1735, 7091,
+5551, 886, 358, 321, 63, 6187, 4068, 7350, 6185, 4029, 3942,
+5552, 765, 773, 1318, 776, 5455, 7897, 7588, 5461, 5460, 7663,
+5553, 955, 800, 481, 337, 2277, 5873, 5624, 5965, 5966, 4447,
+5554, 485, 235, 967, 812, 4458, 6038, 7337, 7986, 7300, 2313,
+5555, 175, 812, 174, 30, 1843, 1842, 1410, 3597, 7536, 3598,
+5556, 848, 295, 439, 1003, 7464, 4315, 7369, 2414, 7914, 6941,
+5557, 561, 618, 650, 1290, 5010, 5017, 5016, 6827, 7929, 7684,
+5558, 1040, 885, 1041, 321, 2525, 2527, 2529, 7412, 7289, 7351,
+5559, 1177, 651, 716, 1278, 7440, 5233, 7909, 3410, 7740, 7002,
+5560, 9, 148, 331, 786, 3551, 7394, 3966, 7100, 1764, 7089,
+5561, 77, 899, 221, 76, 6062, 2066, 7186, 1600, 5847, 6859,
+5562, 727, 1344, 712, 1314, 7837, 7942, 5277, 7806, 2727, 7894,
+5563, 480, 336, 372, 953, 4445, 4123, 4464, 5607, 6998, 7117,
+5564, 814, 236, 32, 329, 5613, 3700, 7107, 5611, 4043, 3961,
+5565, 987, 410, 518, 411, 5921, 4579, 5827, 7969, 4231, 4580,
+5566, 563, 497, 1205, 1073, 4782, 7766, 7805, 5644, 7645, 3098,
+5567, 484, 378, 965, 568, 4456, 6294, 7005, 4736, 4878, 5638,
+5568, 225, 332, 787, 366, 4045, 7984, 7081, 4112, 4111, 5889,
+5569, 782, 938, 1013, 454, 2226, 2572, 2444, 5856, 6757, 5851,
+5570, 10, 332, 150, 787, 3969, 8027, 3552, 7080, 7984, 1768,
+5571, 243, 902, 242, 40, 7689, 7034, 3724, 3722, 7035, 3720,
+5572, 975, 390, 391, 244, 6085, 4171, 7957, 6212, 4167, 4169,
+5573, 403, 983, 909, 827, 6478, 2359, 6647, 6557, 2358, 2196,
+5574, 501, 389, 1163, 500, 4524, 6022, 6032, 4526, 4522, 6023,
+5575, 978, 905, 822, 247, 2345, 2160, 2346, 7461, 6656, 6659,
+5576, 1019, 864, 1020, 347, 2462, 2464, 2466, 7552, 5793, 6087,
+5577, 1122, 498, 582, 455, 7601, 4855, 7838, 6662, 4517, 4854,
+5578, 1338, 763, 1294, 765, 6612, 7835, 3213, 7589, 5416, 6321,
+5579, 710, 1289, 745, 1270, 7279, 7924, 5376, 6812, 3207, 6811,
+5580, 55, 877, 317, 878, 7988, 7493, 3934, 7840, 2005, 7526,
+5581, 672, 1269, 1254, 1256, 7585, 3390, 6849, 7612, 3444, 3447,
+5582, 700, 1289, 745, 710, 7278, 7924, 5337, 5312, 7279, 5376,
+5583, 1354, 1360, 767, 1369, 1650, 6367, 6365, 1651, 1646, 7652,
+5584, 712, 711, 670, 1304, 5219, 5216, 5217, 7129, 6925, 7128,
+5585, 1252, 709, 748, 734, 6248, 5368, 6784, 6246, 5306, 5369,
+5586, 822, 246, 44, 189, 7458, 3732, 7513, 1870, 7659, 7875,
+5587, 519, 1185, 1194, 1160, 7427, 3056, 6133, 6134, 3026, 3054,
+5588, 1250, 643, 679, 663, 7372, 5115, 6854, 6855, 5074, 5122,
+5589, 766, 1357, 1361, 1333, 7046, 1652, 7833, 7049, 1693, 1694,
+5590, 1035, 1136, 1034, 465, 2858, 2857, 2511, 7452, 7542, 7708,
+5591, 859, 1014, 308, 1015, 2448, 7566, 5801, 2449, 2451, 6558,
+5592, 255, 198, 256, 909, 6452, 7716, 3763, 6983, 2091, 6648,
+5593, 403, 256, 909, 402, 4205, 6648, 6647, 4207, 4203, 7230,
+5594, 1109, 411, 988, 1160, 6523, 6892, 2771, 2936, 7739, 2934,
+5595, 859, 1014, 858, 345, 2448, 2447, 1948, 8028, 7194, 6575,
+5596, 1319, 702, 760, 742, 6005, 5395, 6464, 6466, 5328, 5396,
+5597, 859, 345, 858, 36, 8028, 6575, 1948, 7567, 4001, 7550,
+5598, 325, 70, 361, 893, 3951, 4034, 4095, 7595, 7039, 7038,
+5599, 744, 1356, 742, 1322, 7614, 6957, 5336, 7825, 1688, 8012,
+5600, 213, 890, 67, 68, 2040, 7243, 7995, 6270, 7428, 1591,
+5601, 360, 68, 891, 324, 4032, 7919, 6642, 4094, 3949, 6641,
+5602, 1330, 1323, 735, 1295, 1699, 5927, 7982, 1685, 1698, 7454,
+5603, 456, 1014, 308, 345, 6116, 7566, 4367, 4368, 7194, 4103,
+5604, 37, 859, 181, 36, 5802, 1946, 7106, 1560, 7567, 7568,
+5605, 1033, 878, 317, 877, 2504, 7526, 7327, 2503, 2005, 7493,
+5606, 37, 36, 181, 818, 1560, 7568, 7106, 8029, 7363, 1862,
+5607, 308, 1014, 859, 345, 7566, 2448, 5801, 4103, 7194, 8028,
+5608, 1098, 533, 996, 532, 6903, 5717, 2744, 5982, 4627, 5718,
+5609, 870, 1025, 350, 1026, 2480, 7531, 6780, 2482, 2484, 7202,
+5610, 856, 237, 142, 106, 6580, 7857, 1939, 7817, 3703, 3671,
+5611, 870, 1025, 869, 313, 2480, 2479, 1981, 6782, 7636, 7634,
+5612, 1000, 1054, 538, 436, 2570, 6311, 7373, 7177, 7347, 4642,
+5613, 459, 1025, 350, 313, 7530, 7531, 4378, 4379, 7636, 4060,
+5614, 1098, 533, 613, 534, 6903, 4950, 6501, 6502, 4630, 4951,
+5615, 284, 112, 82, 113, 7293, 3617, 3845, 7774, 1466, 3618,
+5616, 350, 1025, 870, 313, 7531, 2480, 6780, 4060, 7636, 6782,
+5617, 108, 79, 78, 280, 3610, 1528, 3609, 6635, 3835, 3834,
+5618, 1098, 533, 998, 996, 6903, 7484, 2743, 2744, 5717, 2401,
+5619, 998, 533, 429, 996, 7484, 4625, 5715, 2401, 5717, 5716,
+5620, 1353, 738, 750, 725, 6615, 5355, 6613, 7633, 5322, 5352,
+5621, 435, 290, 291, 927, 4302, 3868, 4303, 6456, 6455, 7029,
+5622, 319, 1037, 881, 1036, 7234, 2515, 5595, 7353, 2517, 2513,
+5623, 1067, 1007, 1164, 544, 2622, 2949, 2953, 7778, 7867, 6259,
+5624, 466, 1036, 319, 355, 7352, 7353, 4400, 4401, 5504, 4089,
+5625, 921, 281, 109, 79, 5695, 7389, 2117, 7749, 3836, 3611,
+5626, 1007, 442, 543, 443, 7062, 4658, 7063, 7174, 4328, 4660,
+5627, 303, 935, 137, 304, 7697, 2146, 7695, 3907, 6125, 7972,
+5628, 856, 343, 105, 937, 8030, 3995, 7925, 2218, 7828, 7926,
+5629, 675, 750, 725, 1324, 5353, 5352, 5269, 5989, 7904, 6634,
+5630, 105, 343, 306, 937, 3995, 4356, 3912, 7926, 7828, 6429,
+5631, 850, 130, 96, 298, 1927, 3649, 5832, 5833, 7343, 3887,
+5632, 341, 810, 484, 378, 7122, 7108, 4453, 4136, 7109, 4456,
+5633, 151, 226, 12, 789, 7996, 3680, 3557, 1773, 7082, 7796,
+5634, 162, 337, 800, 799, 6778, 5966, 1806, 1804, 5967, 1808,
+5635, 601, 1249, 1184, 609, 7360, 3337, 5680, 4888, 6884, 6661,
+5636, 1263, 1204, 1175, 585, 3361, 3308, 3376, 6358, 8008, 7225,
+5637, 164, 801, 231, 802, 1810, 5870, 7195, 1812, 1814, 7336,
+5638, 950, 949, 496, 1082, 2263, 6383, 6891, 2685, 2684, 6338,
+5639, 792, 948, 947, 369, 2255, 2257, 2253, 6791, 6438, 6792,
+5640, 880, 1036, 319, 881, 2512, 7353, 5594, 2014, 2513, 5595,
+5641, 793, 334, 228, 476, 6385, 4075, 6409, 6387, 4427, 4426,
+5642, 988, 411, 987, 1160, 6892, 7969, 2597, 2934, 7739, 2935,
+5643, 468, 357, 490, 1040, 4406, 4486, 4487, 7411, 7395, 7565,
+5644, 643, 663, 1249, 609, 5074, 6856, 7361, 5072, 5073, 6884,
+5645, 670, 1292, 665, 586, 6056, 7790, 5121, 5090, 6686, 5078,
+5646, 1127, 1025, 459, 1126, 2830, 7530, 7320, 2832, 2828, 7319,
+5647, 191, 905, 823, 46, 2082, 2192, 1872, 7990, 6462, 6461,
+5648, 681, 1191, 1173, 1247, 7864, 3047, 6262, 6241, 3305, 3304,
+5649, 1249, 643, 1250, 663, 7361, 7372, 3348, 6856, 5074, 6855,
+5650, 1046, 1047, 491, 324, 2547, 7976, 7756, 6640, 7007, 4491,
+5651, 543, 640, 1164, 641, 4977, 7981, 6260, 4979, 4981, 6261,
+5652, 462, 1131, 1132, 1030, 5782, 2847, 7496, 5783, 2843, 2845,
+5653, 459, 1025, 1127, 1026, 7530, 2830, 7320, 7532, 2484, 2831,
+5654, 908, 826, 255, 254, 2195, 6982, 7730, 6878, 6877, 3760,
+5655, 196, 908, 52, 51, 2089, 7274, 7273, 7803, 8003, 1575,
+5656, 1040, 357, 490, 1039, 7395, 4486, 7565, 2526, 7549, 7564,
+5657, 1024, 370, 349, 313, 6739, 4120, 5508, 7635, 4119, 4100,
+5658, 913, 831, 265, 988, 2200, 7575, 6713, 2372, 2371, 6897,
+5659, 472, 1048, 361, 1047, 6675, 6868, 4416, 7432, 2550, 7012,
+5660, 1164, 543, 1068, 1168, 6260, 6514, 2950, 2964, 6515, 2962,
+5661, 639, 1186, 1099, 1168, 6517, 3029, 6041, 6519, 3028, 2989,
+5662, 1057, 986, 407, 1105, 2583, 6947, 7413, 2761, 2760, 7423,
+5663, 886, 63, 321, 885, 6185, 3942, 7350, 2029, 7291, 7289,
+5664, 635, 1171, 636, 706, 6305, 6762, 4966, 5202, 7959, 5203,
+5665, 1195, 644, 646, 655, 7055, 5022, 7533, 7870, 5049, 5050,
+5666, 361, 324, 472, 1047, 4071, 4417, 4416, 7012, 7007, 7432,
+5667, 77, 838, 222, 816, 7118, 1901, 6162, 6120, 1903, 1856,
+5668, 1173, 1191, 681, 633, 3047, 7864, 6262, 8031, 6798, 5124,
+5669, 976, 997, 1100, 387, 2398, 2786, 2749, 6079, 7593, 7688,
+5670, 276, 919, 275, 73, 6026, 7261, 3823, 3821, 6028, 3819,
+5671, 210, 267, 832, 915, 6672, 5549, 1889, 2103, 6797, 2170,
+5672, 480, 953, 372, 1084, 5607, 7117, 4464, 7792, 2694, 7417,
+5673, 491, 1047, 472, 324, 7976, 7432, 4492, 4491, 7007, 4417,
+5674, 1100, 499, 495, 1183, 7958, 4764, 7852, 3053, 5683, 7520,
+5675, 1100, 1183, 1184, 499, 3053, 3100, 3024, 7958, 5683, 5682,
+5676, 1164, 640, 543, 1168, 7981, 4977, 6260, 2964, 6520, 6515,
+5677, 1294, 763, 745, 765, 7835, 5408, 7640, 6321, 5416, 5415,
+5678, 1340, 763, 745, 1294, 5969, 5408, 5970, 3261, 7835, 7640,
+5679, 41, 40, 186, 820, 1564, 5901, 5751, 5753, 5902, 1865,
+5680, 370, 530, 567, 1125, 4676, 4765, 4732, 6738, 8014, 7649,
+5681, 1338, 765, 1318, 776, 7589, 7588, 1726, 7095, 5461, 7663,
+5682, 1265, 1327, 727, 1314, 3448, 7836, 6393, 3462, 3126, 7806,
+5683, 395, 1058, 394, 248, 7013, 7665, 4183, 4181, 6755, 4179,
+5684, 1338, 763, 765, 776, 6612, 5416, 7589, 7095, 5479, 5461,
+5685, 727, 773, 1327, 752, 5442, 6439, 7836, 5363, 5443, 7206,
+5686, 777, 763, 1338, 776, 5467, 6612, 6492, 5482, 5479, 7095,
+5687, 1210, 717, 610, 607, 5963, 5232, 7196, 5995, 5231, 4891,
+5688, 409, 912, 986, 262, 8016, 2368, 8015, 4223, 7425, 7771,
+5689, 473, 1049, 472, 1150, 6608, 6609, 4488, 7111, 2900, 7581,
+5690, 703, 698, 1331, 1317, 5192, 6582, 6942, 6699, 6583, 3282,
+5691, 771, 1348, 738, 750, 7673, 6616, 5437, 5435, 6614, 5355,
+5692, 614, 1268, 657, 1302, 6470, 7941, 5057, 6774, 3485, 7752,
+5693, 1035, 487, 1137, 1136, 5505, 7299, 2860, 2858, 7578, 2862,
+5694, 628, 674, 1244, 592, 5097, 7679, 6141, 5043, 5098, 7655,
+5695, 268, 267, 65, 915, 3799, 3795, 3797, 6832, 6797, 6796,
+5696, 891, 69, 892, 324, 7920, 8007, 2047, 6641, 3948, 7015,
+5697, 1244, 1299, 1277, 674, 3474, 3397, 3406, 7679, 7410, 5561,
+5698, 1231, 487, 604, 553, 7579, 4866, 7808, 7385, 4687, 4867,
+5699, 526, 1162, 1108, 420, 5721, 2948, 5719, 4605, 8032, 6915,
+5700, 394, 1058, 978, 248, 7665, 2587, 7664, 4179, 6755, 7954,
+5701, 355, 487, 1035, 465, 4471, 5505, 5503, 4399, 4472, 7452,
+5702, 395, 248, 249, 1058, 4181, 3742, 4182, 7013, 6755, 8033,
+5703, 296, 930, 440, 295, 7747, 7754, 4318, 3883, 7462, 4317,
+5704, 1315, 654, 712, 1314, 7233, 5218, 7127, 1741, 7807, 7894,
+5705, 249, 248, 823, 1058, 3742, 6460, 6751, 8033, 6755, 2585,
+5706, 823, 1058, 396, 249, 2585, 6918, 7921, 6751, 8033, 4184,
+5707, 1053, 475, 364, 454, 5637, 4424, 5636, 6061, 4463, 4441,
+5708, 396, 1058, 395, 249, 6918, 7013, 4186, 4184, 8033, 4182,
+5709, 1320, 666, 1275, 717, 7176, 6342, 3536, 6906, 5243, 5964,
+5710, 1053, 1115, 1052, 475, 2796, 2974, 2566, 5637, 7616, 5941,
+5711, 275, 1062, 276, 422, 7072, 7931, 3823, 4262, 6065, 4263,
+5712, 1276, 662, 1328, 717, 7791, 7726, 3266, 5962, 5235, 6905,
+5713, 285, 84, 924, 114, 3849, 6956, 6771, 6168, 3621, 2124,
+5714, 397, 508, 980, 398, 4546, 6510, 6509, 4192, 4547, 7826,
+5715, 239, 37, 240, 818, 3711, 3713, 3715, 7342, 8029, 6835,
+5716, 281, 280, 921, 365, 3838, 6636, 5695, 4108, 4107, 5897,
+5717, 845, 926, 1066, 289, 2209, 2618, 2617, 7163, 7863, 7899,
+5718, 46, 47, 823, 192, 1570, 7040, 6461, 7989, 7259, 1871,
+5719, 1000, 1004, 539, 1170, 2419, 7086, 7087, 2976, 2975, 7131,
+5720, 305, 139, 936, 103, 7978, 2148, 7189, 3908, 3665, 7980,
+5721, 534, 431, 1063, 995, 4629, 5912, 7349, 7482, 7486, 2608,
+5722, 287, 843, 925, 431, 6960, 2178, 5874, 4291, 7071, 5875,
+5723, 873, 352, 1029, 315, 7855, 7500, 2491, 7781, 4062, 5996,
+5724, 430, 995, 843, 431, 7485, 2391, 5881, 4292, 7486, 7071,
+5725, 1155, 633, 705, 634, 7742, 5198, 7846, 7478, 4960, 5199,
+5726, 844, 433, 1002, 926, 7474, 5816, 2413, 2179, 5817, 2412,
+5727, 1348, 1370, 771, 1367, 1641, 7674, 7673, 1640, 1612, 6537,
+5728, 254, 982, 253, 908, 6879, 5761, 3757, 6878, 2355, 7937,
+5729, 1008, 445, 1167, 1069, 7173, 5734, 2958, 2645, 5736, 2957,
+5730, 705, 1173, 681, 633, 7845, 6262, 5286, 5198, 8031, 5124,
+5731, 118, 117, 844, 288, 1471, 1916, 1915, 7876, 7562, 7563,
+5732, 1155, 1173, 705, 633, 2991, 7845, 7846, 7742, 8031, 5198,
+5733, 941, 786, 331, 785, 2235, 7089, 7099, 2234, 1766, 5669,
+5734, 1320, 717, 1276, 1328, 6906, 5962, 3265, 1618, 6905, 3266,
+5735, 1067, 545, 1008, 444, 7776, 7583, 2644, 7777, 4664, 5768,
+5736, 12, 13, 790, 333, 1505, 5693, 7795, 3972, 3971, 7686,
+5737, 172, 809, 341, 810, 1834, 6317, 5652, 1836, 1838, 7122,
+5738, 1008, 852, 445, 1069, 2428, 7948, 7173, 2645, 2631, 5736,
+5739, 1119, 578, 1196, 599, 5953, 6080, 3062, 6166, 4876, 7676,
+5740, 606, 1228, 1199, 579, 6678, 3218, 6864, 4875, 6694, 6747,
+5741, 1327, 773, 727, 739, 6439, 5442, 7836, 6442, 5445, 5381,
+5742, 1016, 453, 452, 344, 7824, 4360, 5533, 5835, 4359, 4354,
+5743, 723, 696, 1309, 729, 5281, 6340, 6391, 5313, 5305, 6497,
+5744, 776, 773, 1351, 739, 5460, 6440, 7312, 5459, 5445, 6441,
+5745, 704, 666, 1320, 717, 5197, 7176, 6372, 5339, 5243, 6906,
+5746, 1118, 453, 599, 574, 7970, 4851, 7675, 7393, 4757, 4882,
+5747, 1045, 360, 1046, 471, 7504, 6643, 2544, 5629, 4414, 7758,
+5748, 1044, 359, 1043, 888, 6483, 7624, 2538, 2536, 5820, 2534,
+5749, 1018, 862, 346, 1017, 2458, 7510, 7254, 2460, 2456, 7964,
+5750, 576, 618, 551, 1202, 4913, 4912, 4770, 6486, 8034, 7736,
+5751, 229, 797, 159, 796, 6592, 1797, 6593, 7918, 1799, 1795,
+5752, 1177, 581, 549, 1212, 5510, 4797, 7436, 3134, 5511, 6717,
+5753, 1339, 751, 1363, 1366, 6913, 7744, 1663, 1664, 6416, 1606,
+5754, 445, 301, 933, 300, 4333, 7851, 7172, 4332, 3898, 7479,
+5755, 955, 799, 373, 954, 2276, 7671, 5914, 2278, 2274, 5620,
+5756, 480, 577, 373, 1085, 4773, 4775, 4467, 5622, 7810, 5621,
+5757, 1210, 1176, 1276, 607, 3301, 3402, 3404, 5995, 8035, 5994,
+5758, 179, 817, 180, 35, 1860, 1859, 1416, 5822, 5825, 6180,
+5759, 1328, 662, 730, 717, 7726, 5287, 6564, 6905, 5235, 5288,
+5760, 980, 251, 397, 398, 7058, 4188, 6509, 7826, 4190, 4192,
+5761, 445, 852, 446, 1069, 7948, 7779, 4337, 5736, 2631, 7371,
+5762, 835, 992, 419, 917, 2384, 7617, 7762, 2204, 2382, 7977,
+5763, 1265, 752, 746, 720, 6394, 5362, 5852, 6233, 5361, 5310,
+5764, 781, 223, 77, 5, 6046, 3958, 6045, 5603, 3675, 3673,
+5765, 43, 821, 188, 246, 8036, 1867, 5778, 3731, 7643, 7658,
+5766, 1239, 588, 504, 620, 8009, 4813, 6314, 8018, 4920, 4919,
+5767, 1254, 588, 1239, 620, 7690, 8009, 3331, 6850, 4920, 8018,
+5768, 1156, 504, 394, 393, 6173, 4535, 6174, 7718, 4534, 4180,
+5769, 1308, 1241, 680, 1262, 3509, 6701, 6272, 3508, 3353, 6256,
+5770, 1309, 729, 1330, 1323, 6497, 6498, 1748, 3412, 5928, 1699,
+5771, 318, 880, 1035, 355, 7650, 2510, 7451, 4065, 6325, 5503,
+5772, 471, 1147, 561, 491, 5631, 6114, 4708, 4490, 7751, 4707,
+5773, 701, 1339, 1310, 699, 6911, 3150, 7955, 5244, 6542, 6540,
+5774, 1079, 369, 947, 1080, 7927, 6792, 2676, 2680, 7928, 2678,
+5775, 833, 269, 990, 1061, 6805, 7239, 2379, 2599, 7556, 2600,
+5776, 594, 696, 1259, 630, 5149, 6290, 6401, 4947, 5173, 6291,
+5777, 623, 1181, 1238, 1179, 6846, 3272, 6847, 8037, 3164, 3273,
+5778, 66, 211, 210, 888, 6335, 1447, 7854, 5821, 2034, 2033,
+5779, 558, 1204, 1151, 554, 7699, 3093, 8038, 4744, 7734, 7429,
+5780, 766, 1357, 756, 1369, 7046, 6283, 5421, 7834, 1653, 6284,
+5781, 1263, 1207, 1274, 585, 3396, 3395, 1744, 6358, 5906, 5905,
+5782, 1145, 470, 551, 576, 6431, 4682, 7849, 5598, 4768, 4770,
+5783, 1176, 607, 1210, 598, 8035, 5995, 3301, 6899, 4881, 6388,
+5784, 858, 35, 181, 36, 6179, 8001, 1944, 7550, 1559, 7568,
+5785, 999, 840, 426, 972, 2403, 8039, 7290, 2405, 2329, 7170,
+5786, 59, 204, 203, 881, 7251, 1440, 8006, 7422, 2013, 2012,
+5787, 181, 35, 858, 180, 8001, 6179, 1944, 1417, 6180, 1943,
+5788, 297, 442, 441, 931, 4323, 4325, 4321, 5565, 7203, 5564,
+5789, 59, 881, 203, 58, 7422, 2012, 8006, 1582, 5597, 6171,
+5790, 847, 1004, 438, 437, 2418, 6953, 7380, 6838, 6839, 4313,
+5791, 1006, 541, 440, 1003, 7748, 4652, 7491, 2579, 5707, 7498,
+5792, 438, 929, 439, 1004, 7366, 7367, 4316, 6953, 2417, 6952,
+5793, 848, 125, 93, 126, 1924, 3641, 7465, 1923, 1479, 3642,
+5794, 868, 46, 45, 190, 6773, 1569, 6772, 1973, 7271, 6775,
+5795, 869, 46, 192, 47, 8040, 7989, 1977, 7901, 1570, 7259,
+5796, 703, 1346, 1355, 736, 7700, 1604, 7780, 5316, 6920, 6512,
+5797, 881, 59, 319, 58, 7422, 3938, 5595, 5597, 1582, 3939,
+5798, 25, 805, 168, 167, 7885, 1822, 3585, 3586, 1821, 1403,
+5799, 1109, 520, 413, 412, 6362, 4586, 7724, 6522, 4585, 4237,
+5800, 192, 46, 869, 191, 7989, 8040, 1977, 1428, 7990, 1976,
+5801, 789, 226, 12, 333, 7082, 3680, 7796, 7797, 4046, 3972,
+5802, 715, 1303, 1321, 675, 5867, 1736, 7257, 5228, 7962, 5987,
+5803, 393, 247, 978, 246, 4176, 7461, 7719, 4175, 3736, 7459,
+5804, 962, 806, 807, 233, 2297, 1829, 2298, 7812, 7813, 8022,
+5805, 213, 68, 67, 916, 6270, 1591, 7995, 2104, 6197, 6195,
+5806, 392, 973, 821, 904, 7453, 2330, 7641, 7642, 2340, 2159,
+5807, 214, 69, 834, 917, 7079, 6211, 1893, 2107, 6986, 2172,
+5808, 63, 831, 914, 266, 8010, 2169, 5583, 3791, 8011, 5582,
+5809, 1264, 1226, 1197, 498, 2985, 3258, 3363, 6010, 6810, 6009,
+5810, 1221, 1108, 1110, 525, 3179, 2776, 3180, 7150, 7358, 7357,
+5811, 215, 69, 892, 214, 8041, 8007, 2046, 1451, 7079, 2045,
+5812, 324, 68, 891, 69, 3949, 7919, 6641, 3948, 1592, 7920,
+5813, 617, 1226, 1264, 498, 6808, 2985, 7227, 4911, 6810, 6010,
+5814, 23, 165, 22, 338, 3582, 3579, 1515, 3981, 6279, 3982,
+5815, 232, 803, 23, 338, 5651, 6278, 3693, 4079, 6280, 3981,
+5816, 1273, 752, 1318, 761, 6901, 7898, 3171, 6298, 5423, 6297,
+5817, 313, 46, 869, 47, 3927, 8040, 7634, 3926, 1570, 7901,
+5818, 368, 333, 946, 477, 4115, 7968, 7965, 4432, 4431, 7917,
+5819, 1218, 1217, 595, 1190, 3162, 6749, 6495, 3178, 3433, 6053,
+5820, 1110, 525, 418, 524, 7357, 4601, 5919, 5936, 4603, 4599,
+5821, 822, 904, 246, 189, 2191, 7460, 7458, 1870, 2080, 7659,
+5822, 726, 1289, 1297, 1340, 7364, 3192, 6594, 5968, 3193, 3131,
+5823, 567, 1126, 1227, 1127, 7318, 3068, 5608, 7321, 2832, 3212,
+5824, 45, 189, 867, 190, 7874, 1970, 6398, 6775, 1426, 1971,
+5825, 680, 1262, 627, 673, 6256, 6243, 5164, 5165, 6277, 5095,
+5826, 368, 477, 946, 1078, 4432, 7917, 7965, 5585, 5586, 2673,
+5827, 1129, 1028, 1130, 488, 2837, 2839, 2841, 7503, 5999, 6695,
+5828, 1130, 1029, 1131, 488, 2840, 2842, 2844, 6695, 5997, 7501,
+5829, 1310, 673, 690, 1248, 6714, 5155, 8042, 3514, 8025, 7761,
+5830, 828, 985, 260, 259, 2362, 6102, 6103, 6327, 6111, 3775,
+5831, 1034, 318, 1035, 465, 7767, 7451, 2511, 7708, 4396, 7452,
+5832, 407, 260, 1057, 406, 4217, 7993, 7413, 4219, 4215, 6395,
+5833, 1131, 1029, 462, 488, 2842, 5784, 5782, 7501, 5997, 4476,
+5834, 1259, 686, 1221, 630, 6289, 7060, 3358, 6291, 5140, 6730,
+5835, 1321, 1324, 1348, 750, 1738, 1696, 1722, 7258, 7904, 6614,
+5836, 745, 1294, 734, 1270, 7640, 6320, 5390, 6811, 3535, 6247,
+5837, 1130, 1228, 1129, 488, 3217, 3216, 2841, 6695, 6693, 7503,
+5838, 1208, 1274, 616, 610, 3398, 5555, 5553, 5619, 5763, 4909,
+5839, 1129, 1228, 492, 488, 3216, 6677, 7502, 7503, 6693, 4505,
+5840, 975, 244, 903, 820, 6212, 6213, 2334, 2335, 6529, 2158,
+5841, 483, 1093, 962, 1092, 7137, 2723, 7398, 7397, 2725, 2721,
+5842, 705, 1173, 1112, 1236, 7845, 2990, 5756, 5757, 3251, 3250,
+5843, 869, 313, 349, 46, 7634, 4100, 7698, 8040, 3927, 4010,
+5844, 869, 46, 868, 191, 8040, 6773, 1978, 1976, 7990, 1974,
+5845, 1184, 587, 1188, 501, 6089, 6034, 3173, 6660, 4808, 7631,
+5846, 538, 1054, 537, 435, 6311, 7368, 4643, 4641, 7175, 4639,
+5847, 903, 245, 42, 244, 7768, 3728, 6655, 6213, 3730, 3726,
+5848, 500, 388, 1100, 499, 4521, 7516, 7517, 4523, 4520, 7958,
+5849, 982, 401, 826, 254, 5992, 5991, 2357, 6879, 4199, 6877,
+5850, 855, 104, 140, 139, 6945, 3667, 1937, 1938, 3666, 1493,
+5851, 1341, 1347, 1305, 728, 1690, 1743, 1742, 8043, 7286, 8044,
+5852, 868, 46, 869, 349, 6773, 8040, 1978, 5509, 4010, 7698,
+5853, 659, 1305, 722, 728, 6968, 7822, 5256, 5278, 8044, 5279,
+5854, 659, 733, 1341, 728, 5301, 7548, 6789, 5278, 5302, 8043,
+5855, 989, 831, 265, 266, 2374, 7575, 5578, 5579, 8011, 3793,
+5856, 1305, 1347, 722, 728, 1743, 7285, 7822, 8044, 7286, 5279,
+5857, 1140, 1039, 1141, 490, 2870, 2872, 2874, 6128, 7564, 6127,
+5858, 1377, 207, 264, 62, 7678, 7809, 6709, 7573, 7622, 3786,
+5859, 914, 831, 989, 266, 2169, 2374, 2373, 5582, 8011, 5579,
+5860, 1304, 1344, 711, 1337, 2728, 8045, 6925, 2982, 1731, 7647,
+5861, 403, 1104, 513, 512, 6477, 5544, 4562, 4561, 7314, 4564,
+5862, 602, 1144, 1234, 576, 7401, 3239, 7853, 4861, 5599, 5600,
+5863, 362, 325, 473, 1049, 4072, 4420, 4419, 7551, 6610, 6608,
+5864, 269, 916, 67, 270, 6804, 6195, 3801, 3805, 6196, 3803,
+5865, 1299, 690, 1310, 699, 7680, 8042, 3155, 7661, 5181, 6540,
+5866, 605, 1201, 648, 1267, 6532, 6533, 5009, 7091, 3463, 6489,
+5867, 1045, 323, 890, 360, 6177, 7244, 2540, 7504, 4070, 7246,
+5868, 945, 789, 790, 333, 2246, 1778, 2247, 7967, 7797, 7686,
+5869, 1079, 570, 1078, 477, 8005, 5584, 2677, 7915, 4741, 5586,
+5870, 712, 1344, 711, 1304, 7942, 8045, 5219, 7129, 2728, 6925,
+5871, 66, 833, 67, 269, 6333, 6800, 1590, 3800, 6805, 3801,
+5872, 947, 477, 227, 369, 7916, 4430, 6100, 6792, 4433, 4118,
+5873, 471, 323, 1045, 360, 4415, 6177, 5629, 4414, 4070, 7504,
+5874, 1079, 1078, 946, 477, 2677, 2673, 2675, 7915, 5586, 7917,
+5875, 944, 226, 945, 368, 6221, 8019, 2248, 5745, 4116, 5744,
+5876, 219, 837, 75, 74, 1900, 7121, 7119, 7307, 7775, 1598,
+5877, 580, 1081, 369, 1080, 6902, 6437, 4791, 7604, 2683, 7928,
+5878, 558, 1152, 473, 1151, 7220, 7219, 4698, 8038, 2907, 7110,
+5879, 214, 68, 891, 213, 6783, 7919, 2043, 1450, 6270, 2042,
+5880, 558, 1205, 1152, 1204, 7443, 3096, 7220, 7699, 3099, 3094,
+5881, 253, 982, 254, 400, 5761, 6879, 3757, 4196, 5738, 4197,
+5882, 1052, 896, 327, 363, 2560, 7305, 5940, 5939, 7316, 4097,
+5883, 413, 266, 989, 412, 4235, 5579, 7402, 4237, 4233, 5580,
+5884, 1364, 1368, 1349, 774, 1622, 1621, 1623, 6485, 6479, 7471,
+5885, 1243, 1258, 594, 593, 3343, 6346, 6345, 6637, 7521, 4833,
+5886, 532, 531, 1001, 1189, 4624, 6228, 6293, 5983, 6229, 3037,
+5887, 527, 1218, 595, 1190, 6494, 6495, 4837, 6306, 3178, 6053,
+5888, 375, 339, 804, 960, 4129, 5615, 5522, 5524, 5494, 2291,
+5889, 856, 937, 1012, 343, 2218, 2438, 2437, 8030, 7828, 7540,
+5890, 369, 598, 580, 1080, 4848, 4862, 4791, 7928, 6900, 7604,
+5891, 856, 343, 1012, 237, 8030, 7540, 2437, 6580, 3994, 6227,
+5892, 1055, 520, 1182, 521, 7725, 6363, 3017, 7923, 4591, 7148,
+5893, 1001, 531, 428, 427, 6228, 4621, 7818, 6577, 4620, 4283,
+5894, 1287, 1304, 1271, 665, 3267, 3492, 3438, 6931, 6926, 6697,
+5895, 1198, 619, 1271, 652, 6704, 6950, 3386, 6705, 5029, 6698,
+5896, 1198, 1271, 1227, 652, 3386, 3385, 3215, 6705, 6698, 6702,
+5897, 328, 898, 1013, 899, 5845, 2445, 5849, 5848, 2068, 2442,
+5898, 219, 74, 75, 327, 7307, 1598, 7119, 7304, 3955, 3954,
+5899, 478, 939, 224, 367, 7801, 6987, 4436, 4437, 6752, 4113,
+5900, 897, 898, 75, 220, 2065, 5844, 5843, 2061, 2063, 7120,
+5901, 1329, 754, 1297, 1340, 7884, 6606, 3130, 1680, 7757, 3131,
+5902, 1297, 754, 726, 1340, 6606, 5370, 6594, 3131, 7757, 5968,
+5903, 1329, 777, 780, 754, 7288, 5488, 7287, 7884, 5468, 5485,
+5904, 758, 1329, 780, 754, 7945, 7287, 5486, 5480, 7884, 5485,
+5905, 1161, 972, 569, 531, 2937, 7171, 6238, 6230, 8046, 4749,
+5906, 569, 972, 427, 531, 7171, 6579, 4739, 4749, 8046, 4620,
+5907, 1099, 542, 1006, 541, 7275, 6225, 2746, 6665, 4656, 7748,
+5908, 1001, 972, 1161, 531, 2410, 2937, 2939, 6228, 8046, 6230,
+5909, 1353, 721, 725, 1324, 6553, 5283, 7633, 1697, 6549, 6634,
+5910, 1007, 543, 1164, 544, 7063, 6260, 2949, 7867, 4663, 6259,
+5911, 1255, 1294, 734, 761, 3461, 6320, 7379, 6296, 6322, 5401,
+5912, 56, 878, 879, 201, 7839, 2008, 7895, 6331, 2004, 2006,
+5913, 910, 828, 259, 985, 2197, 6327, 6348, 2363, 2362, 6111,
+5914, 826, 255, 254, 401, 6982, 3760, 6877, 5991, 4200, 4199,
+5915, 727, 1327, 1265, 752, 7836, 3448, 6393, 5363, 7206, 6394,
+5916, 1068, 543, 1164, 1007, 6514, 6260, 2950, 2628, 7063, 2949,
+5917, 427, 972, 1001, 531, 6579, 2410, 6577, 4620, 8046, 6228,
+5918, 198, 255, 256, 53, 6452, 3763, 7716, 6451, 3759, 3761,
+5919, 1310, 673, 1308, 701, 6714, 6273, 3224, 7955, 5188, 6274,
+5920, 670, 608, 1292, 586, 5088, 6058, 6056, 5090, 4885, 6686,
+5921, 539, 1170, 636, 1171, 7131, 6303, 4965, 7594, 2987, 6762,
+5922, 1318, 1294, 1255, 761, 3214, 3461, 3538, 6297, 6322, 6296,
+5923, 1318, 765, 1294, 761, 7588, 6321, 3214, 6297, 5417, 6322,
+5924, 747, 706, 1192, 1236, 5343, 5799, 5938, 5556, 5755, 3252,
+5925, 758, 1300, 1329, 754, 6814, 3125, 7945, 5480, 7944, 7884,
+5926, 1351, 739, 757, 768, 6441, 5387, 6434, 7311, 5428, 5427,
+5927, 1253, 689, 1297, 741, 7123, 6595, 3467, 7600, 5327, 6596,
+5928, 1255, 734, 748, 761, 7379, 5369, 7378, 6296, 5401, 5400,
+5929, 659, 645, 647, 1285, 5062, 5001, 5063, 7511, 5539, 5538,
+5930, 691, 1193, 589, 621, 7717, 7208, 5157, 5158, 6092, 4815,
+5931, 507, 621, 1107, 622, 4922, 7535, 6016, 4923, 4924, 6018,
+5932, 306, 855, 450, 305, 6430, 8047, 4348, 3913, 7979, 4347,
+5933, 1006, 542, 440, 541, 6225, 4654, 7491, 7748, 4656, 4652,
+5934, 683, 1238, 743, 693, 6863, 7896, 5331, 5265, 6862, 5330,
+5935, 1042, 322, 469, 358, 7879, 4410, 6029, 7400, 4092, 4407,
+5936, 1330, 756, 1343, 735, 7938, 6970, 1678, 7982, 5379, 7820,
+5937, 678, 640, 1220, 709, 5214, 6370, 6368, 5234, 5212, 6152,
+5938, 714, 619, 1286, 687, 5222, 6946, 7843, 5225, 5144, 6069,
+5939, 1111, 415, 990, 414, 5516, 5517, 2778, 6020, 4243, 6019,
+5940, 749, 1300, 758, 754, 7629, 6814, 5452, 5447, 7944, 5480,
+5941, 471, 470, 1044, 323, 4483, 7147, 6176, 4415, 4413, 6178,
+5942, 749, 741, 1297, 754, 5351, 6596, 7597, 5447, 5371, 6606,
+5943, 1299, 740, 1342, 1333, 7409, 6829, 3142, 3141, 8000, 1695,
+5944, 1086, 565, 1178, 1085, 6378, 5908, 3003, 2704, 6380, 3135,
+5945, 1178, 1213, 649, 1087, 3139, 6138, 5907, 3004, 3137, 7506,
+5946, 540, 541, 638, 1166, 4653, 4971, 4970, 5704, 5705, 5863,
+5947, 676, 719, 697, 1280, 5239, 5242, 5175, 6351, 8048, 6356,
+5948, 580, 1080, 1176, 1081, 7604, 2999, 7603, 6902, 2683, 3000,
+5949, 1330, 735, 1343, 1295, 7982, 7820, 1678, 1685, 7454, 1684,
+5950, 664, 1316, 1282, 669, 7576, 3113, 7889, 5172, 7738, 6048,
+5951, 572, 1215, 612, 1216, 7570, 6842, 4895, 7553, 3154, 7892,
+5952, 1350, 739, 1351, 1344, 6443, 6441, 1649, 1702, 6845, 1703,
+5953, 1337, 1350, 739, 757, 1700, 6443, 6844, 6555, 6436, 5387,
+5954, 1337, 757, 739, 711, 6555, 5387, 6844, 7647, 5383, 5324,
+5955, 787, 332, 943, 366, 7984, 8049, 2240, 5889, 4111, 5888,
+5956, 918, 274, 420, 993, 6670, 4257, 7056, 2385, 7066, 6916,
+5957, 742, 775, 760, 1358, 5458, 5457, 5396, 6467, 6268, 6465,
+5958, 274, 993, 421, 420, 7066, 7074, 4259, 4257, 6916, 4261,
+5959, 1275, 610, 1210, 717, 5617, 7196, 3401, 5964, 5232, 5963,
+5960, 730, 662, 1291, 718, 5287, 7727, 8050, 5290, 5238, 7560,
+5961, 1328, 662, 1276, 1278, 7726, 7791, 3266, 3259, 7728, 3408,
+5962, 396, 250, 823, 249, 4185, 7042, 7921, 4184, 3745, 6751,
+5963, 954, 799, 230, 798, 2274, 6996, 5604, 2273, 1805, 6999,
+5964, 19, 798, 160, 336, 8051, 1800, 3573, 3977, 7000, 7064,
+5965, 230, 798, 19, 336, 6999, 8051, 3689, 4077, 7000, 3977,
+5966, 1155, 1191, 1173, 633, 3045, 3047, 2991, 7742, 6798, 8031,
+5967, 161, 160, 19, 798, 1396, 3573, 3572, 1801, 1800, 8051,
+5968, 450, 855, 1010, 305, 8047, 2434, 6433, 4347, 7979, 7190,
+5969, 230, 161, 19, 798, 6785, 3572, 3689, 6999, 1801, 8051,
+5970, 572, 1091, 1215, 1092, 7974, 3147, 7570, 7555, 2722, 3149,
+5971, 639, 1099, 638, 541, 6041, 5865, 4975, 4973, 6665, 4971,
+5972, 316, 1030, 1031, 875, 5806, 2499, 8004, 6876, 2495, 2497,
+5973, 964, 1093, 963, 377, 2726, 2724, 2305, 7032, 7033, 7140,
+5974, 403, 1104, 512, 983, 6477, 7314, 4561, 6478, 2758, 7315,
+5975, 28, 809, 172, 171, 7014, 1834, 3592, 3593, 1833, 1407,
+5976, 341, 809, 172, 28, 6317, 1834, 5652, 3988, 7014, 3592,
+5977, 1134, 1229, 1230, 552, 3222, 3253, 3223, 6536, 8052, 6967,
+5978, 1087, 565, 1178, 1086, 6379, 5908, 3004, 2707, 6378, 3003,
+5979, 649, 565, 1178, 1087, 5012, 5908, 5907, 7506, 6379, 3004,
+5980, 208, 831, 914, 63, 1887, 2169, 2101, 7722, 8010, 5583,
+5981, 1330, 756, 735, 732, 7938, 5379, 7982, 6499, 5378, 5314,
+5982, 1261, 600, 645, 552, 7639, 4995, 5541, 7773, 4853, 4996,
+5983, 910, 258, 55, 257, 6373, 3767, 6764, 5975, 3769, 3765,
+5984, 744, 742, 724, 1322, 5336, 5329, 5334, 7825, 8012, 7626,
+5985, 694, 1241, 625, 695, 6105, 7618, 5169, 5266, 6840, 5267,
+5986, 208, 831, 63, 62, 1887, 8010, 7722, 7623, 7574, 1586,
+5987, 63, 831, 265, 62, 8010, 7575, 3789, 1586, 7574, 3788,
+5988, 842, 113, 83, 114, 1912, 3619, 7158, 1911, 1467, 3620,
+5989, 406, 985, 1057, 1106, 6110, 2582, 6395, 6396, 2763, 2765,
+5990, 1230, 552, 1229, 1261, 6967, 8052, 3253, 3350, 7773, 3351,
+5991, 733, 774, 1349, 764, 5449, 7471, 7469, 5412, 5450, 6447,
+5992, 429, 998, 923, 842, 5715, 2400, 5714, 6954, 2399, 2222,
+5993, 285, 998, 429, 842, 7816, 5715, 4285, 7157, 2399, 6954,
+5994, 671, 1345, 1309, 732, 7016, 1747, 6292, 5295, 7935, 6500,
+5995, 703, 736, 1355, 721, 5316, 6512, 7780, 5248, 5317, 8053,
+5996, 1272, 618, 1202, 1290, 6904, 8034, 3389, 3452, 7929, 3453,
+5997, 1202, 618, 561, 1290, 8034, 5010, 6825, 3453, 7929, 6827,
+5998, 1229, 600, 1261, 552, 7868, 7639, 3351, 8052, 4853, 7773,
+5999, 935, 853, 447, 303, 2188, 5725, 7159, 7697, 7991, 4339,
+6000, 935, 303, 447, 448, 7697, 4339, 7159, 6123, 4341, 4343,
+6001, 375, 1091, 571, 376, 8054, 7975, 4748, 4450, 7610, 4747,
+6002, 303, 853, 447, 302, 7991, 5725, 4339, 3904, 7992, 4338,
+6003, 1319, 1312, 702, 1311, 3377, 6004, 6005, 3210, 3529, 5986,
+6004, 712, 739, 711, 1344, 5325, 5324, 5219, 7942, 6845, 8045,
+6005, 702, 724, 1319, 1311, 5263, 7388, 6005, 5986, 5686, 3210,
+6006, 1102, 399, 400, 982, 6997, 4198, 5737, 2752, 5760, 5738,
+6007, 1121, 1019, 384, 1120, 2812, 5950, 5949, 2814, 2810, 7584,
+6008, 902, 40, 185, 39, 7035, 5900, 2076, 7036, 1563, 8055,
+6009, 186, 863, 185, 40, 1959, 1958, 1422, 5901, 7268, 5900,
+6010, 1066, 926, 433, 289, 2618, 5817, 5815, 7899, 7863, 4297,
+6011, 41, 347, 42, 864, 4007, 4006, 1565, 7130, 5793, 5792,
+6012, 646, 1225, 1195, 1257, 6627, 3356, 7533, 6630, 3355, 3341,
+6013, 187, 41, 42, 864, 7625, 1565, 7209, 1962, 7130, 5792,
+6014, 53, 876, 198, 875, 7715, 1997, 6451, 7512, 1999, 1995,
+6015, 351, 194, 871, 872, 7632, 1983, 6589, 6590, 1985, 1987,
+6016, 53, 875, 197, 52, 7512, 1994, 6449, 1576, 6875, 7269,
+6017, 353, 876, 53, 875, 5502, 7715, 4019, 5501, 1999, 7512,
+6018, 53, 316, 353, 875, 3932, 4063, 4019, 7512, 6876, 5501,
+6019, 52, 316, 53, 875, 3933, 3932, 1576, 6875, 6876, 7512,
+6020, 53, 52, 197, 255, 1576, 7269, 6449, 3759, 3758, 6450,
+6021, 757, 1350, 1365, 1362, 6436, 1642, 6435, 6933, 1643, 1637,
+6022, 1065, 435, 1066, 434, 6421, 6454, 2650, 6422, 4304, 7341,
+6023, 1198, 1228, 492, 1129, 3219, 6677, 7882, 3071, 3216, 7502,
+6024, 845, 290, 88, 289, 6737, 3863, 7161, 7163, 3865, 3861,
+6025, 64, 887, 209, 886, 6192, 2030, 7670, 6186, 2032, 2028,
+6026, 317, 354, 55, 878, 4064, 4021, 3934, 7526, 7527, 7840,
+6027, 701, 1322, 1308, 1339, 7939, 3227, 6274, 6911, 1686, 3225,
+6028, 1198, 1129, 492, 1128, 3071, 7502, 7882, 3070, 2838, 7827,
+6029, 248, 905, 978, 247, 6463, 2345, 7954, 3739, 6656, 7461,
+6030, 571, 1091, 1090, 1215, 7975, 2719, 7313, 6841, 3147, 3146,
+6031, 1101, 1194, 591, 1224, 3055, 6607, 6513, 3196, 3195, 6976,
+6032, 228, 949, 371, 794, 6894, 6889, 4122, 5959, 2259, 7247,
+6033, 690, 673, 1310, 699, 5155, 6714, 8042, 5181, 5180, 6540,
+6034, 1141, 490, 468, 556, 6127, 4487, 8056, 6726, 4693, 4692,
+6035, 285, 842, 83, 114, 7157, 7158, 3848, 6168, 1911, 3620,
+6036, 401, 982, 1113, 400, 5992, 2788, 7444, 4201, 5738, 5739,
+6037, 1343, 756, 770, 735, 6970, 5432, 6969, 7820, 5379, 5433,
+6038, 897, 220, 75, 219, 2061, 7120, 5843, 2060, 1456, 7119,
+6039, 897, 1053, 364, 898, 2563, 5636, 5841, 2065, 2564, 5842,
+6040, 961, 376, 339, 233, 5602, 4132, 5495, 7811, 4131, 4080,
+6041, 1142, 556, 1141, 468, 7494, 6726, 2877, 6880, 4692, 8056,
+6042, 1116, 511, 401, 1113, 5513, 4556, 7438, 2944, 5514, 7444,
+6043, 1052, 896, 363, 1051, 2560, 7316, 5939, 2562, 2558, 6419,
+6044, 947, 477, 946, 227, 7916, 7917, 2254, 6100, 4430, 6099,
+6045, 363, 895, 73, 326, 7798, 7862, 4039, 4073, 6683, 3952,
+6046, 254, 51, 52, 908, 3755, 1575, 3756, 6878, 8003, 7274,
+6047, 947, 369, 1079, 477, 6792, 7927, 2676, 7916, 4433, 7915,
+6048, 20, 799, 162, 161, 6779, 1804, 3574, 3575, 1803, 1397,
+6049, 21, 801, 231, 164, 7301, 5870, 3691, 3578, 1810, 7195,
+6050, 196, 51, 52, 874, 7803, 1575, 7273, 1991, 7280, 6874,
+6051, 253, 908, 825, 51, 7937, 2163, 6719, 3753, 8003, 7804,
+6052, 254, 908, 253, 51, 6878, 7937, 3757, 3755, 8003, 3753,
+6053, 342, 235, 812, 30, 4055, 7300, 6722, 3990, 3698, 7536,
+6054, 401, 1113, 511, 400, 7444, 5514, 4556, 4201, 5739, 4555,
+6055, 485, 967, 968, 812, 7337, 2317, 5811, 7986, 2313, 2315,
+6056, 485, 968, 342, 812, 5811, 5915, 4457, 7986, 2315, 6722,
+6057, 979, 823, 396, 906, 2348, 7921, 6543, 2347, 2161, 6546,
+6058, 74, 73, 219, 919, 1597, 6098, 7307, 6027, 6028, 2110,
+6059, 47, 906, 193, 48, 7041, 2084, 7260, 1571, 7953, 6585,
+6060, 136, 101, 303, 102, 3660, 3902, 7696, 3661, 1551, 3903,
+6061, 623, 509, 510, 1179, 4925, 4554, 4926, 8037, 7534, 5658,
+6062, 302, 101, 853, 135, 3900, 7180, 7992, 7160, 3659, 1934,
+6063, 275, 1062, 836, 919, 7072, 2603, 7075, 7261, 2605, 2174,
+6064, 622, 1179, 1107, 509, 7345, 3027, 6018, 4820, 7534, 6971,
+6065, 848, 1003, 439, 929, 2414, 6941, 7369, 2210, 2415, 7367,
+6066, 724, 742, 1319, 1322, 5329, 6466, 7388, 7626, 8012, 1714,
+6067, 724, 1322, 1308, 701, 7626, 3227, 5684, 5333, 7939, 6274,
+6068, 441, 931, 1068, 1006, 5564, 2624, 6222, 6224, 2424, 2625,
+6069, 1250, 642, 679, 643, 5728, 5114, 6854, 7372, 4988, 5115,
+6070, 1177, 651, 1211, 1082, 7440, 6199, 3128, 3127, 7538, 3122,
+6071, 433, 288, 289, 926, 4296, 3862, 4297, 5817, 7877, 7863,
+6072, 120, 845, 88, 119, 1917, 7161, 3631, 1473, 1918, 3630,
+6073, 1066, 290, 845, 289, 6453, 6737, 2617, 7899, 3865, 7163,
+6074, 1002, 536, 1065, 434, 5838, 7476, 2781, 8024, 4637, 6422,
+6075, 925, 432, 288, 287, 5876, 4294, 7561, 5874, 4293, 3859,
+6076, 778, 744, 1372, 772, 5469, 7830, 6994, 5472, 5466, 6475,
+6077, 478, 563, 1073, 497, 4781, 5644, 7644, 4780, 4782, 7645,
+6078, 1176, 580, 1211, 607, 7603, 8057, 3123, 8035, 4880, 6198,
+6079, 367, 939, 224, 783, 6752, 6987, 4113, 6882, 2228, 6988,
+6080, 997, 1072, 386, 818, 2642, 7602, 7044, 2397, 2639, 7043,
+6081, 34, 1375, 237, 1, 6506, 7858, 3705, 1557, 7187, 3704,
+6082, 3, 1375, 107, 1, 6763, 6424, 1460, 3606, 7187, 3607,
+6083, 1339, 744, 701, 1322, 6912, 5335, 6911, 1686, 7825, 7939,
+6084, 1331, 1355, 1353, 721, 1603, 1609, 1689, 6554, 8053, 6553,
+6085, 1076, 1207, 1075, 575, 3106, 3105, 2668, 5890, 7078, 5892,
+6086, 954, 953, 480, 1084, 2275, 5607, 5605, 2696, 2694, 7792,
+6087, 738, 1355, 736, 721, 6666, 6512, 5323, 5321, 8053, 5317,
+6088, 59, 58, 203, 829, 1582, 6171, 8006, 7887, 7994, 1884,
+6089, 778, 1372, 769, 772, 6994, 6473, 5474, 5472, 6475, 5438,
+6090, 984, 983, 403, 827, 2593, 6478, 6476, 2361, 2358, 6557,
+6091, 417, 270, 991, 416, 4247, 7132, 7621, 4249, 4245, 7114,
+6092, 483, 1093, 572, 493, 7137, 7554, 4751, 4507, 7031, 4753,
+6093, 418, 271, 991, 417, 4250, 7217, 5918, 4252, 4248, 7621,
+6094, 549, 480, 372, 1084, 4677, 4464, 4678, 7437, 7792, 7417,
+6095, 969, 379, 424, 1097, 7344, 4617, 5895, 2741, 5794, 5627,
+6096, 1162, 993, 1108, 420, 2941, 2768, 2948, 8032, 6916, 6915,
+6097, 17, 796, 159, 158, 7985, 1795, 3569, 3567, 1794, 1394,
+6098, 961, 1091, 960, 376, 2718, 2717, 2296, 5602, 7610, 5601,
+6099, 17, 796, 795, 335, 7985, 1796, 6231, 3975, 7606, 6232,
+6100, 572, 612, 615, 1216, 4895, 4904, 4903, 7553, 7892, 7611,
+6101, 1229, 1135, 553, 552, 3220, 7387, 7933, 8052, 7787, 4788,
+6102, 263, 409, 830, 410, 4224, 5886, 5691, 4226, 4228, 5922,
+6103, 484, 377, 568, 964, 4455, 4734, 4736, 7006, 7032, 7861,
+6104, 551, 618, 561, 1202, 4912, 5010, 4709, 7736, 8034, 6825,
+6105, 1073, 1115, 367, 497, 2795, 6753, 7646, 7645, 7799, 4726,
+6106, 1001, 427, 428, 841, 6577, 4283, 7818, 2408, 7783, 5711,
+6107, 572, 1215, 571, 612, 7570, 6841, 4794, 4895, 6842, 4896,
+6108, 1094, 1093, 615, 1217, 2731, 7608, 5525, 3158, 3157, 5526,
+6109, 428, 841, 427, 283, 5711, 7783, 4283, 4281, 5713, 4279,
+6110, 681, 1247, 656, 1191, 6241, 5786, 5125, 7864, 3305, 5787,
+6111, 37, 818, 181, 182, 8029, 1862, 7106, 6423, 1861, 1418,
+6112, 1216, 664, 1217, 1283, 7890, 6750, 3156, 3431, 7577, 3432,
+6113, 664, 686, 1316, 723, 5150, 6344, 7576, 5258, 5257, 5671,
+6114, 1171, 1236, 1192, 706, 3249, 3252, 3049, 7959, 5755, 5799,
+6115, 297, 850, 298, 442, 5834, 5833, 3889, 4323, 6940, 4324,
+6116, 1008, 851, 1067, 444, 2629, 2623, 2644, 5768, 5767, 7777,
+6117, 444, 300, 933, 851, 4330, 7479, 5766, 5767, 7951, 2186,
+6118, 1171, 1192, 636, 706, 3049, 5798, 6762, 7959, 5799, 5203,
+6119, 283, 112, 284, 841, 8058, 7293, 3847, 5713, 1909, 5712,
+6120, 284, 112, 283, 82, 7293, 8058, 3847, 3845, 3617, 3843,
+6121, 82, 112, 283, 81, 3617, 8058, 3843, 1531, 3616, 3842,
+6122, 748, 1246, 1192, 707, 7685, 3307, 6096, 5346, 6113, 5800,
+6123, 405, 1106, 513, 984, 6644, 5542, 4565, 6118, 2764, 7475,
+6124, 318, 879, 880, 57, 7651, 2011, 7650, 3936, 7900, 6326,
+6125, 513, 1104, 1174, 512, 5544, 2992, 7472, 4564, 7314, 6458,
+6126, 111, 112, 283, 841, 1465, 8058, 7156, 1910, 1909, 5713,
+6127, 457, 530, 1125, 1124, 4618, 8014, 6276, 8002, 6729, 2826,
+6128, 615, 493, 572, 1093, 4902, 4753, 4903, 7608, 7031, 7554,
+6129, 270, 1061, 269, 916, 7133, 7556, 3805, 6196, 2601, 6804,
+6130, 283, 112, 111, 81, 8058, 1465, 7156, 3842, 3616, 3615,
+6131, 293, 123, 292, 91, 7788, 7709, 3874, 3872, 3637, 3870,
+6132, 1007, 443, 932, 850, 7174, 5741, 2426, 2427, 6936, 2185,
+6133, 42, 311, 43, 865, 3923, 3922, 1566, 5781, 7292, 5780,
+6134, 230, 480, 373, 954, 4444, 4467, 4126, 5604, 5605, 5620,
+6135, 336, 797, 229, 952, 7065, 6592, 4049, 6742, 2268, 6741,
+6136, 966, 378, 810, 235, 7023, 7109, 2309, 6037, 4135, 7054,
+6137, 42, 245, 903, 821, 3728, 7768, 6655, 7210, 7769, 2155,
+6138, 965, 964, 484, 568, 2308, 7006, 7005, 5638, 7861, 4736,
+6139, 1115, 454, 1053, 938, 6756, 6061, 2796, 2793, 6757, 2655,
+6140, 292, 847, 123, 293, 7710, 1922, 7709, 3874, 7381, 7788,
+6141, 292, 90, 91, 123, 3869, 1540, 3870, 7709, 3636, 3637,
+6142, 973, 244, 391, 245, 6214, 4169, 7391, 7770, 3730, 4170,
+6143, 242, 902, 243, 977, 7034, 7689, 3724, 6888, 2342, 6861,
+6144, 380, 1017, 1018, 346, 7096, 2460, 7097, 4139, 7964, 7254,
+6145, 380, 1018, 451, 346, 7097, 7569, 4352, 4139, 7254, 4351,
+6146, 241, 819, 901, 38, 6149, 2157, 6148, 3716, 5925, 6163,
+6147, 1185, 629, 1260, 1182, 7656, 5590, 3346, 3172, 7149, 3365,
+6148, 462, 1030, 352, 1029, 5783, 5805, 4389, 5784, 2496, 7500,
+6149, 352, 315, 462, 1029, 4062, 4390, 4389, 7500, 5996, 5784,
+6150, 1186, 640, 639, 709, 6518, 4978, 6517, 6151, 5212, 5211,
+6151, 822, 189, 45, 190, 1870, 7874, 6658, 1869, 1426, 6775,
+6152, 1123, 460, 1022, 1124, 5746, 5633, 2819, 2823, 5634, 2821,
+6153, 352, 1030, 316, 874, 5805, 5806, 4086, 7270, 2494, 6873,
+6154, 122, 90, 292, 123, 3635, 3869, 7355, 1476, 3636, 7709,
+6155, 427, 283, 922, 282, 4279, 7784, 6578, 4278, 3844, 7165,
+6156, 921, 1005, 280, 839, 2423, 6352, 6636, 2116, 2421, 6353,
+6157, 1154, 569, 426, 456, 5789, 4738, 7169, 5790, 4737, 4714,
+6158, 1134, 1135, 1229, 552, 2856, 3220, 3222, 6536, 7787, 8052,
+6159, 546, 445, 446, 1069, 4667, 4337, 4668, 5735, 5736, 7371,
+6160, 100, 302, 934, 135, 3899, 7216, 7205, 3658, 7160, 2144,
+6161, 1010, 1183, 548, 1071, 3022, 6802, 5807, 2637, 3050, 5665,
+6162, 1010, 855, 936, 305, 2434, 2217, 2432, 7190, 7979, 7189,
+6163, 140, 937, 141, 105, 2151, 2150, 1494, 3668, 7926, 3669,
+6164, 309, 1017, 346, 862, 7212, 7964, 4056, 6159, 2456, 7510,
+6165, 370, 1025, 459, 313, 7966, 7530, 4380, 4119, 7636, 4379,
+6166, 346, 310, 40, 863, 4105, 3921, 4004, 7255, 5643, 7268,
+6167, 1341, 1305, 659, 728, 1742, 6968, 6789, 8043, 8044, 5278,
+6168, 468, 490, 1141, 1040, 4487, 6127, 8056, 7411, 7565, 2873,
+6169, 1231, 553, 1229, 1135, 7385, 7933, 3221, 3077, 7387, 3220,
+6170, 353, 875, 316, 1031, 5501, 6876, 4063, 5500, 2497, 8004,
+6171, 415, 269, 990, 268, 4242, 7239, 5517, 4241, 3802, 6831,
+6172, 191, 46, 190, 905, 7990, 7271, 1427, 2082, 6462, 2083,
+6173, 66, 888, 65, 359, 5821, 7450, 1589, 4030, 5820, 4031,
+6174, 1041, 468, 1142, 1040, 6881, 6880, 2876, 2529, 7411, 2875,
+6175, 1142, 468, 1141, 1040, 6880, 8056, 2877, 2875, 7411, 2873,
+6176, 576, 618, 1202, 1234, 4913, 8034, 6486, 5600, 7660, 3262,
+6177, 434, 290, 1066, 289, 4300, 6453, 7341, 4299, 3865, 7899,
+6178, 88, 120, 89, 290, 3631, 3632, 1538, 3863, 6833, 3864,
+6179, 100, 301, 99, 134, 3897, 3896, 1549, 3657, 7224, 3656,
+6180, 437, 292, 847, 928, 4308, 7710, 6838, 7178, 7711, 2224,
+6181, 697, 669, 1316, 723, 5250, 7738, 5670, 5320, 5270, 5671,
+6182, 473, 1050, 474, 326, 7266, 6598, 4493, 4421, 6691, 4423,
+6183, 537, 1054, 1112, 1065, 7368, 2782, 7467, 6420, 2615, 2783,
+6184, 191, 46, 868, 190, 7990, 6773, 1974, 1427, 7271, 1973,
+6185, 420, 992, 525, 419, 6914, 7359, 4604, 4258, 7617, 4602,
+6186, 1024, 457, 349, 370, 6275, 4371, 5508, 6739, 4373, 4120,
+6187, 942, 225, 787, 366, 7113, 7081, 2238, 5887, 4112, 5889,
+6188, 383, 368, 1077, 573, 4149, 5743, 7191, 4755, 4754, 7997,
+6189, 1076, 1207, 616, 1208, 3106, 5554, 7077, 3108, 3110, 5553,
+6190, 224, 784, 146, 783, 5700, 1758, 7823, 6988, 1760, 1756,
+6191, 383, 573, 1077, 1076, 4755, 7997, 7191, 5904, 7998, 2671,
+6192, 573, 1076, 383, 575, 7998, 5904, 4755, 4762, 5890, 4759,
+6193, 1062, 993, 1162, 421, 2604, 2941, 2940, 6064, 7074, 6063,
+6194, 678, 1237, 1220, 641, 5570, 3255, 6368, 5112, 5571, 6369,
+6195, 21, 800, 231, 801, 7204, 5871, 3691, 7301, 1811, 5870,
+6196, 1211, 651, 1177, 1278, 6199, 7440, 3128, 3409, 7740, 3410,
+6197, 373, 565, 1086, 1085, 4722, 6378, 7201, 5621, 6380, 2704,
+6198, 428, 923, 429, 996, 5764, 5714, 4286, 7819, 2393, 5716,
+6199, 1164, 641, 1172, 544, 6261, 7181, 2981, 6259, 4980, 7182,
+6200, 705, 634, 1112, 1155, 5199, 7468, 5756, 7846, 7478, 2920,
+6201, 1196, 1118, 1119, 599, 3061, 2808, 3062, 7676, 7675, 6166,
+6202, 1117, 574, 1206, 1161, 6237, 5956, 3102, 3060, 5957, 3101,
+6203, 1172, 642, 545, 641, 6254, 4983, 6253, 7181, 4985, 4982,
+6204, 85, 115, 286, 84, 3623, 7703, 3852, 1534, 3622, 3851,
+6205, 429, 285, 430, 998, 4285, 4287, 4289, 5715, 7816, 7487,
+6206, 430, 285, 924, 998, 4287, 6771, 5884, 7487, 7816, 2402,
+6207, 7, 145, 330, 783, 3546, 5972, 3964, 6758, 1755, 5971,
+6208, 922, 841, 111, 283, 2223, 1910, 2119, 7784, 5713, 7156,
+6209, 510, 509, 399, 1102, 4554, 4550, 4552, 5659, 6989, 6997,
+6210, 977, 389, 242, 974, 6095, 4163, 6888, 2343, 5679, 5677,
+6211, 421, 993, 1162, 420, 7074, 2941, 6063, 4261, 6916, 8032,
+6212, 1325, 719, 676, 1280, 6736, 5239, 6507, 3421, 8048, 6351,
+6213, 384, 1020, 1121, 458, 5951, 2813, 5949, 4376, 6086, 7211,
+6214, 1353, 1355, 738, 721, 1609, 6666, 6615, 6553, 8053, 5321,
+6215, 603, 1205, 1175, 1074, 7441, 3189, 6219, 5930, 3188, 2997,
+6216, 866, 311, 1021, 865, 7682, 7093, 2468, 1969, 7292, 2467,
+6217, 979, 1058, 396, 823, 2588, 6918, 6543, 2348, 2585, 7921,
+6218, 766, 1333, 753, 740, 7049, 8059, 5422, 5419, 8000, 5366,
+6219, 7, 6, 330, 145, 1499, 3965, 3964, 3546, 3543, 5972,
+6220, 603, 1207, 616, 575, 6220, 5554, 5031, 5004, 7078, 5142,
+6221, 1175, 558, 603, 585, 7442, 4864, 6219, 7225, 4804, 4901,
+6222, 563, 1073, 1205, 1074, 5644, 3098, 7805, 5646, 2660, 3188,
+6223, 1085, 577, 611, 1212, 7810, 4892, 6381, 3133, 6718, 6382,
+6224, 549, 1084, 1177, 1212, 7437, 3002, 7436, 6717, 3132, 3134,
+6225, 558, 585, 1204, 554, 4804, 8008, 7699, 4744, 4805, 7734,
+6226, 649, 1213, 1088, 1087, 6138, 3138, 6137, 7506, 3137, 2710,
+6227, 1140, 1039, 490, 1038, 2870, 7564, 6128, 2869, 2523, 7546,
+6228, 527, 1218, 528, 596, 6494, 6922, 4613, 4839, 6496, 4840,
+6229, 821, 904, 188, 246, 2159, 2081, 1867, 7643, 7460, 7658,
+6230, 1082, 651, 549, 1177, 7538, 5019, 6336, 3127, 7440, 7436,
+6231, 1175, 1204, 558, 585, 3308, 7699, 7442, 7225, 8008, 4804,
+6232, 1216, 664, 1282, 612, 7890, 7889, 3430, 7892, 5118, 7020,
+6233, 148, 331, 147, 8, 7394, 5667, 1383, 3549, 3967, 3547,
+6234, 1053, 1052, 327, 475, 2566, 5940, 5635, 5637, 5941, 4425,
+6235, 823, 192, 47, 906, 1871, 7259, 7040, 2161, 2085, 7041,
+6236, 542, 640, 639, 1168, 4976, 4978, 4974, 6516, 6520, 6519,
+6237, 493, 1094, 568, 964, 7303, 5640, 4735, 7030, 2729, 7861,
+6238, 1169, 643, 642, 1250, 6258, 4988, 5727, 3293, 7372, 5728,
+6239, 679, 642, 1250, 1237, 5114, 5728, 6854, 7310, 5572, 3323,
+6240, 512, 1104, 1174, 1116, 7314, 2992, 6458, 6459, 2799, 2993,
+6241, 1164, 1172, 1067, 544, 2981, 2980, 2953, 6259, 7182, 7778,
+6242, 1067, 1172, 545, 544, 2980, 6253, 7776, 7778, 7182, 4666,
+6243, 664, 669, 1282, 612, 5172, 6048, 7889, 5118, 5087, 7020,
+6244, 1293, 1235, 650, 1290, 3500, 7880, 6308, 3039, 3503, 7684,
+6245, 664, 1216, 1217, 615, 7890, 3156, 6750, 5117, 7611, 5526,
+6246, 990, 915, 267, 268, 2377, 6797, 7333, 6831, 6832, 3799,
+6247, 756, 766, 713, 1357, 5421, 5420, 5380, 6283, 7046, 7047,
+6248, 977, 389, 1163, 390, 6095, 6022, 3011, 6084, 4168, 6033,
+6249, 572, 1216, 615, 1093, 7553, 7611, 4903, 7554, 3153, 7608,
+6250, 667, 597, 650, 1293, 5081, 5018, 5082, 6744, 6310, 6308,
+6251, 405, 513, 404, 984, 4565, 4563, 4213, 6118, 7475, 5499,
+6252, 1364, 742, 775, 774, 6484, 5458, 6266, 6485, 5473, 5481,
+6253, 1196, 599, 644, 574, 7676, 4991, 6082, 7392, 4882, 4992,
+6254, 848, 93, 930, 126, 7465, 7463, 2183, 1923, 3642, 2137,
+6255, 427, 282, 922, 972, 4278, 7165, 6578, 6579, 7746, 2328,
+6256, 730, 1346, 703, 762, 7701, 7700, 5391, 5405, 6921, 5409,
+6257, 612, 664, 615, 1216, 5118, 5117, 4904, 7892, 7890, 7611,
+6258, 760, 780, 758, 1334, 5487, 5486, 5397, 6973, 6521, 6972,
+6259, 569, 574, 1161, 531, 4772, 5957, 6238, 4749, 4803, 6230,
+6260, 1351, 768, 757, 1365, 7311, 5427, 6434, 1648, 6265, 6435,
+6261, 1189, 1206, 1196, 574, 3104, 3175, 3314, 5955, 5956, 7392,
+6262, 704, 717, 1320, 730, 5339, 6906, 6372, 5340, 5288, 6562,
+6263, 1024, 1025, 370, 313, 2481, 7966, 6739, 7635, 7636, 4119,
+6264, 452, 1117, 1154, 569, 5532, 2913, 5788, 4740, 6236, 5789,
+6265, 730, 662, 1328, 1291, 5287, 7726, 6564, 8050, 7727, 2736,
+6266, 582, 578, 646, 1225, 4779, 4998, 4997, 6194, 6081, 6627,
+6267, 582, 1226, 1122, 1121, 6809, 3064, 7838, 6215, 3063, 2817,
+6268, 573, 1076, 616, 1208, 7998, 7077, 4908, 7999, 3108, 5553,
+6269, 1209, 610, 1210, 1275, 5618, 7196, 3120, 3400, 5617, 3401,
+6270, 1078, 570, 1209, 1208, 5584, 7434, 3115, 3111, 7435, 3117,
+6271, 1077, 570, 1078, 1208, 7188, 5584, 2674, 3109, 7435, 3111,
+6272, 573, 570, 1077, 1208, 4756, 7188, 7997, 7999, 7435, 3109,
+6273, 616, 570, 573, 1208, 4907, 4756, 4908, 5553, 7435, 7999,
+6274, 1259, 696, 594, 1258, 6290, 5149, 6401, 3345, 6341, 6346,
+6275, 496, 1081, 580, 1082, 6384, 6902, 4792, 6338, 2686, 8060,
+6276, 1283, 686, 1284, 1259, 7571, 6570, 3525, 3534, 6289, 3446,
+6277, 727, 739, 712, 1344, 5381, 5325, 5277, 7837, 6845, 7942,
+6278, 1221, 686, 1284, 631, 7060, 6570, 3442, 7151, 5141, 6569,
+6279, 330, 6, 782, 145, 3965, 6793, 5854, 5972, 3543, 1753,
+6280, 466, 487, 1138, 1036, 4473, 6412, 6413, 7352, 5506, 2863,
+6281, 551, 1146, 1145, 1202, 7735, 2889, 7849, 7736, 3087, 3086,
+6282, 317, 464, 1033, 489, 4395, 7691, 7327, 4481, 4482, 7329,
+6283, 829, 986, 262, 261, 2366, 7771, 7772, 8013, 6949, 3781,
+6284, 1132, 555, 1199, 1131, 5973, 7323, 3073, 2847, 8061, 3072,
+6285, 471, 1146, 551, 1147, 5630, 7735, 4681, 5631, 2892, 6115,
+6286, 955, 481, 373, 337, 5624, 4461, 5914, 5965, 4447, 4125,
+6287, 1372, 1356, 1364, 772, 1635, 1634, 1613, 6475, 6958, 6482,
+6288, 694, 1241, 1242, 625, 6105, 3287, 6104, 5169, 7618, 7523,
+6289, 917, 419, 273, 272, 7977, 4254, 7848, 6985, 4253, 3814,
+6290, 625, 1241, 1242, 1174, 7618, 3287, 7523, 7524, 3281, 3284,
+6291, 347, 310, 1019, 864, 4057, 5641, 7552, 5793, 5642, 2462,
+6292, 699, 751, 1342, 753, 5358, 7302, 6541, 5365, 5367, 6828,
+6293, 690, 673, 591, 1248, 5155, 5096, 5156, 7761, 8025, 6975,
+6294, 777, 1338, 1329, 1359, 6492, 1676, 7288, 6493, 1667, 1677,
+6295, 756, 732, 1330, 1345, 5378, 6499, 7938, 7934, 7935, 1682,
+6296, 1262, 673, 1310, 1248, 6277, 6714, 3515, 3513, 8025, 3514,
+6297, 769, 1348, 771, 750, 7672, 7673, 5436, 5430, 6614, 5435,
+6298, 1044, 470, 471, 1146, 7147, 4483, 6176, 2887, 8062, 5630,
+6299, 1353, 725, 750, 1324, 7633, 5352, 6613, 1697, 6634, 7904,
+6300, 1307, 684, 605, 677, 7732, 5131, 6770, 7253, 5134, 5108,
+6301, 1145, 470, 1044, 1146, 6431, 7147, 2885, 2889, 8062, 2887,
+6302, 1339, 744, 1363, 751, 6912, 7743, 1663, 6913, 5399, 7744,
+6303, 163, 800, 21, 801, 1807, 7204, 3576, 1809, 1811, 7301,
+6304, 371, 794, 950, 795, 7247, 2261, 6890, 6286, 1793, 2262,
+6305, 1309, 696, 732, 729, 6340, 5296, 6500, 6497, 5305, 5304,
+6306, 837, 278, 424, 920, 7872, 4269, 6332, 2175, 5894, 5626,
+6307, 560, 1203, 1293, 597, 6803, 3458, 6309, 4845, 7786, 6310,
+6308, 304, 102, 138, 137, 3905, 3663, 7694, 7972, 3662, 1491,
+6309, 471, 470, 551, 1146, 4483, 4682, 4681, 5630, 8062, 7735,
+6310, 551, 470, 1145, 1146, 4682, 6431, 7849, 7735, 8062, 2889,
+6311, 659, 647, 660, 1285, 5063, 5066, 5139, 7511, 5538, 7723,
+6312, 757, 1347, 1362, 728, 6556, 1670, 6933, 5384, 7286, 6107,
+6313, 648, 1296, 559, 614, 7505, 6867, 5007, 5008, 6471, 4899,
+6314, 535, 1157, 1155, 633, 5655, 2996, 5654, 4955, 6799, 7742,
+6315, 1220, 678, 1240, 1237, 6368, 6287, 3277, 3255, 5570, 3279,
+6316, 1240, 678, 679, 1237, 6287, 5116, 7309, 3279, 5570, 7310,
+6317, 1172, 1237, 1250, 642, 3324, 3323, 3317, 6254, 5572, 5728,
+6318, 1325, 718, 1291, 1279, 6735, 7560, 3495, 3429, 7004, 3454,
+6319, 1063, 1157, 534, 995, 2945, 8063, 7349, 2608, 2923, 7482,
+6320, 534, 1157, 1098, 995, 8063, 2924, 6502, 7482, 2923, 2745,
+6321, 535, 632, 534, 1157, 4953, 4952, 4633, 5655, 6183, 8063,
+6322, 534, 632, 1098, 1157, 4952, 6503, 6502, 8063, 6183, 2924,
+6323, 1158, 495, 387, 386, 6573, 4763, 7591, 7592, 4793, 4159,
+6324, 557, 556, 605, 1201, 4789, 4871, 4870, 6633, 6534, 6532,
+6325, 21, 800, 163, 162, 7204, 1807, 3576, 3577, 1806, 1398,
+6326, 1165, 1183, 601, 1184, 3034, 5681, 6076, 3174, 3100, 5680,
+6327, 240, 387, 386, 997, 4157, 4159, 4155, 6836, 7593, 7044,
+6328, 1295, 1336, 1325, 719, 3129, 3271, 3274, 7455, 7144, 6736,
+6329, 780, 1359, 768, 777, 6406, 6263, 5493, 5488, 6493, 5492,
+6330, 1299, 1248, 1310, 690, 3475, 3514, 3155, 7680, 7761, 8042,
+6331, 1210, 607, 610, 598, 5995, 4891, 7196, 6388, 4881, 4889,
+6332, 1063, 1157, 535, 534, 2945, 5655, 5910, 7349, 8063, 4633,
+6333, 1351, 776, 1365, 1338, 7312, 7094, 1648, 1668, 7095, 1666,
+6334, 735, 1336, 1295, 719, 7457, 3129, 7454, 5402, 7144, 7455,
+6335, 1099, 542, 639, 1168, 7275, 4974, 6041, 2989, 6516, 6519,
+6336, 1244, 1248, 1299, 690, 3312, 3475, 3474, 7681, 7761, 7680,
+6337, 1068, 542, 1006, 1168, 6223, 6225, 2625, 2962, 6516, 2963,
+6338, 504, 503, 1222, 620, 4536, 6169, 6587, 4919, 4811, 7706,
+6339, 558, 1205, 474, 1152, 7443, 7764, 4697, 7220, 3096, 6597,
+6340, 474, 1205, 1153, 1152, 7764, 3097, 7763, 6597, 3096, 2910,
+6341, 1222, 502, 1188, 620, 6073, 6074, 3288, 7706, 4810, 7587,
+6342, 781, 222, 1374, 77, 2070, 7558, 7704, 6045, 6162, 7653,
+6343, 301, 99, 133, 933, 3896, 3655, 7222, 7851, 6887, 2142,
+6344, 77, 76, 221, 838, 1600, 6859, 7186, 7118, 6824, 1902,
+6345, 1006, 542, 1099, 1168, 6225, 7275, 2746, 2963, 6516, 2989,
+6346, 753, 1333, 1342, 740, 8059, 1695, 6828, 5366, 8000, 6829,
+6347, 33, 177, 815, 178, 3604, 1851, 5749, 3603, 1413, 1852,
+6348, 188, 866, 43, 189, 1967, 5587, 5778, 1425, 1968, 8064,
+6349, 43, 866, 44, 189, 5587, 5588, 1567, 8064, 1968, 7875,
+6350, 669, 1214, 583, 653, 6050, 6218, 5085, 5086, 5830, 5037,
+6351, 492, 1128, 381, 566, 7827, 7263, 4504, 4730, 7638, 4728,
+6352, 459, 1126, 370, 567, 7319, 7648, 4380, 4731, 7318, 4732,
+6353, 647, 555, 1230, 564, 4999, 7324, 6560, 5040, 4719, 6966,
+6354, 44, 246, 43, 189, 3732, 3731, 1567, 7875, 7659, 8064,
+6355, 714, 1271, 1287, 1286, 7240, 3438, 7667, 7843, 3437, 3439,
+6356, 43, 246, 188, 189, 3731, 7658, 5778, 8064, 7659, 1425,
+6357, 639, 1246, 1186, 708, 6040, 3299, 6517, 5210, 6072, 6070,
+6358, 670, 1292, 1304, 665, 6056, 3491, 7128, 5121, 7790, 6926,
+6359, 712, 654, 727, 1314, 5218, 5275, 5277, 7894, 7807, 7806,
+6360, 1362, 1347, 1341, 728, 1670, 1690, 1691, 6107, 7286, 8043,
+6361, 540, 1170, 1166, 637, 7126, 2977, 5704, 4968, 5880, 5878,
+6362, 386, 1072, 239, 818, 7602, 7405, 4154, 7043, 2639, 7342,
+6363, 1174, 1223, 513, 625, 3191, 5543, 7472, 7524, 7619, 4932,
+6364, 1251, 1238, 692, 755, 3321, 8021, 7419, 6943, 6944, 5373,
+6365, 692, 1238, 693, 755, 8021, 6862, 5262, 5373, 6944, 5374,
+6366, 450, 306, 1011, 855, 4348, 7103, 7101, 8047, 6430, 2436,
+6367, 693, 743, 755, 1238, 5330, 5377, 5374, 6862, 7896, 6944,
+6368, 638, 708, 637, 1246, 5208, 5207, 4972, 5864, 6072, 5879,
+6369, 479, 372, 1083, 496, 4499, 7416, 7415, 4512, 4724, 6339,
+6370, 623, 1179, 622, 509, 8037, 7345, 4927, 4925, 7534, 4820,
+6371, 708, 1246, 748, 707, 6072, 7685, 5347, 5209, 6113, 5346,
+6372, 623, 1238, 692, 1179, 6847, 8021, 5163, 8037, 3273, 8065,
+6373, 1175, 585, 603, 1207, 7225, 4901, 6219, 3107, 5906, 6220,
+6374, 1288, 1293, 1263, 597, 3526, 3459, 1745, 6745, 6310, 7785,
+6375, 372, 1083, 549, 1084, 7416, 6337, 4678, 7417, 2695, 7437,
+6376, 1249, 643, 1165, 1169, 7361, 6075, 3315, 3316, 6258, 2967,
+6377, 1009, 1070, 547, 447, 2651, 5731, 5732, 5724, 5726, 4671,
+6378, 736, 1355, 1326, 1346, 6512, 1706, 5979, 6920, 1604, 1717,
+6379, 438, 293, 847, 437, 4311, 7381, 7380, 4313, 4309, 6838,
+6380, 439, 295, 440, 1003, 4315, 4317, 4319, 6941, 7914, 7498,
+6381, 847, 928, 1000, 437, 2224, 2407, 2406, 6838, 7178, 6837,
+6382, 934, 1069, 446, 852, 2630, 7371, 7226, 2187, 2631, 7779,
+6383, 910, 257, 55, 200, 5975, 3765, 6764, 2093, 5984, 7841,
+6384, 87, 119, 88, 289, 3629, 3630, 1537, 3860, 7162, 3861,
+6385, 56, 201, 910, 200, 6331, 2092, 6329, 7842, 1437, 2093,
+6386, 56, 910, 55, 200, 6329, 6764, 1579, 7842, 2093, 7841,
+6387, 66, 888, 210, 65, 5821, 2033, 7854, 1589, 7450, 6795,
+6388, 66, 65, 210, 915, 1589, 6795, 7854, 6334, 6796, 2103,
+6389, 692, 1238, 1251, 1179, 8021, 3321, 7419, 8065, 3273, 3319,
+6390, 848, 929, 294, 125, 2210, 6937, 7370, 1924, 2134, 6939,
+6391, 623, 1179, 692, 622, 8037, 8065, 5163, 4927, 7345, 5162,
+6392, 1243, 1258, 593, 1260, 3343, 7521, 6637, 3364, 3387, 7522,
+6393, 1273, 1327, 1318, 752, 3170, 1730, 3171, 6901, 7206, 7898,
+6394, 567, 566, 1227, 652, 4733, 6708, 5608, 5027, 5026, 6702,
+6395, 346, 862, 1018, 863, 7510, 2458, 7254, 7255, 1960, 2459,
+6396, 77, 1374, 2, 816, 7653, 6604, 1601, 6120, 7559, 6140,
+6397, 241, 39, 242, 819, 3717, 3719, 3721, 6149, 7146, 7145,
+6398, 892, 69, 215, 70, 8007, 8041, 2046, 7037, 1593, 7068,
+6399, 361, 69, 892, 70, 4035, 8007, 7011, 4034, 1593, 7037,
+6400, 891, 214, 892, 69, 2043, 2045, 2047, 7920, 7079, 8007,
+6401, 1309, 723, 686, 696, 6391, 5257, 6343, 6340, 5281, 5280,
+6402, 1263, 585, 666, 597, 6358, 5099, 6359, 7785, 4846, 5100,
+6403, 757, 731, 1337, 1347, 5382, 7466, 6555, 6556, 7284, 1701,
+6404, 1219, 630, 1221, 524, 6402, 6730, 3181, 7153, 4946, 7152,
+6405, 45, 189, 44, 867, 7874, 7875, 1568, 6398, 1970, 6397,
+6406, 815, 971, 329, 816, 2324, 6977, 6122, 1857, 2325, 6119,
+6407, 1362, 728, 1341, 733, 6107, 8043, 1691, 6106, 5302, 7548,
+6408, 1337, 711, 739, 1344, 7647, 5324, 6844, 1731, 8045, 6845,
+6409, 524, 523, 1219, 630, 4600, 7702, 7153, 4946, 4945, 6402,
+6410, 692, 1179, 1251, 622, 8065, 3319, 7419, 5162, 7345, 7420,
+6411, 11, 226, 12, 151, 3681, 3680, 1504, 3554, 7996, 3557,
+6412, 42, 821, 43, 245, 7210, 8036, 1566, 3728, 7769, 3729,
+6413, 1029, 873, 315, 1028, 2491, 7781, 5996, 2493, 2489, 5998,
+6414, 463, 1031, 316, 1030, 5796, 8004, 4393, 5797, 2499, 5806,
+6415, 524, 630, 1221, 631, 4946, 6730, 7152, 4948, 5034, 7151,
+6416, 1253, 1251, 691, 741, 3329, 7418, 7599, 7600, 7598, 5350,
+6417, 1297, 1251, 1253, 741, 3466, 3329, 3467, 6596, 7598, 7600,
+6418, 2, 1374, 4, 816, 6604, 6602, 3540, 6140, 7559, 1855,
+6419, 716, 662, 718, 1278, 5236, 5238, 5237, 7002, 7728, 7001,
+6420, 1084, 1212, 549, 577, 3132, 6717, 7437, 7793, 6718, 4774,
+6421, 1221, 631, 1284, 1190, 7151, 6569, 3442, 3182, 6054, 3441,
+6422, 1337, 731, 1287, 1347, 7466, 6930, 2653, 1701, 7284, 2654,
+6423, 713, 1345, 671, 732, 7018, 7016, 5299, 5300, 7935, 5295,
+6424, 1030, 875, 316, 874, 2495, 6876, 5806, 2494, 1996, 6873,
+6425, 1133, 1032, 463, 1031, 2849, 5946, 5945, 2848, 2502, 5796,
+6426, 987, 411, 518, 1160, 7969, 4580, 5827, 2935, 7739, 5828,
+6427, 409, 408, 986, 1060, 4225, 6948, 8015, 5814, 5813, 2595,
+6428, 911, 260, 1057, 986, 5551, 7993, 2581, 2367, 6807, 2583,
+6429, 1057, 260, 407, 986, 7993, 4217, 7413, 2583, 6807, 6947,
+6430, 1244, 674, 628, 690, 7679, 5097, 6141, 7681, 5160, 5159,
+6431, 625, 1241, 680, 695, 7618, 6701, 5119, 5267, 6840, 5260,
+6432, 1362, 764, 757, 728, 6108, 5411, 6933, 6107, 5410, 5384,
+6433, 671, 740, 1277, 713, 5221, 7408, 5560, 5299, 5359, 7017,
+6434, 1284, 631, 595, 1190, 6569, 4838, 7883, 3441, 6054, 6053,
+6435, 962, 807, 340, 233, 2298, 7677, 7759, 7812, 8022, 4053,
+6436, 413, 989, 914, 832, 7402, 2373, 5546, 5547, 2376, 2201,
+6437, 471, 360, 1046, 491, 4414, 6643, 7758, 4490, 4489, 7756,
+6438, 1185, 519, 1109, 1160, 7427, 6524, 3025, 3026, 6134, 2936,
+6439, 168, 233, 26, 806, 8066, 3694, 3588, 1824, 7813, 6132,
+6440, 25, 233, 26, 168, 3695, 3694, 1518, 3585, 8066, 3588,
+6441, 944, 943, 383, 1076, 2245, 5702, 5701, 2667, 2666, 5904,
+6442, 12, 790, 152, 789, 7795, 1776, 3556, 7796, 1778, 1774,
+6443, 749, 1300, 1251, 755, 7629, 3479, 7497, 5375, 6813, 6943,
+6444, 1262, 673, 1248, 1224, 6277, 8025, 3513, 3501, 6316, 3311,
+6445, 392, 973, 391, 245, 7453, 7391, 4174, 4172, 7770, 4170,
+6446, 1276, 1176, 1211, 607, 3402, 3123, 3403, 5994, 8035, 6198,
+6447, 1020, 347, 865, 311, 6087, 5791, 2465, 6088, 4102, 7292,
+6448, 1318, 773, 765, 761, 7897, 5455, 7588, 6297, 5444, 5417,
+6449, 1309, 696, 686, 1259, 6340, 5280, 6343, 3510, 6290, 6289,
+6450, 752, 773, 1318, 761, 5443, 7897, 7898, 5423, 5444, 6297,
+6451, 1354, 1336, 770, 1360, 1704, 7814, 6364, 1650, 1705, 6366,
+6452, 698, 721, 1313, 684, 5249, 6552, 6581, 5284, 5332, 7731,
+6453, 716, 1279, 1177, 1278, 7003, 3415, 7909, 7002, 3443, 3410,
+6454, 698, 684, 1307, 677, 5284, 7732, 5775, 5274, 5134, 7253,
+6455, 1082, 1177, 549, 1083, 3127, 7436, 6336, 2692, 3001, 6337,
+6456, 168, 233, 806, 805, 8066, 7813, 1824, 1822, 7952, 1826,
+6457, 1176, 1081, 1211, 580, 3000, 3121, 3123, 7603, 6902, 8057,
+6458, 716, 718, 1325, 1279, 5237, 6735, 6734, 7003, 7004, 3429,
+6459, 369, 948, 947, 1080, 6438, 2257, 6792, 7928, 2679, 2678,
+6460, 580, 1081, 1211, 1082, 6902, 3121, 8057, 8060, 2686, 3122,
+6461, 1286, 619, 714, 1271, 6946, 5222, 7843, 3437, 6950, 7240,
+6462, 665, 1292, 1271, 586, 7790, 3482, 6697, 5078, 6686, 6685,
+6463, 152, 151, 12, 789, 1387, 3557, 3556, 1774, 1773, 7796,
+6464, 1250, 1256, 679, 1237, 3338, 6853, 6854, 3323, 3339, 7310,
+6465, 703, 1346, 736, 762, 7700, 6920, 5316, 5409, 6921, 5418,
+6466, 961, 805, 806, 233, 2294, 1826, 2295, 7811, 7952, 7813,
+6467, 1227, 1292, 1197, 586, 3456, 3455, 3069, 5610, 6686, 5657,
+6468, 1174, 1181, 1242, 590, 3015, 3285, 3284, 6457, 5577, 7481,
+6469, 1291, 762, 730, 718, 6445, 5405, 8050, 7560, 5404, 5290,
+6470, 1253, 1289, 689, 688, 3457, 7365, 7123, 7376, 7377, 5179,
+6471, 1361, 753, 766, 1333, 7737, 5422, 7833, 1694, 8059, 7049,
+6472, 369, 1081, 580, 476, 6437, 6902, 4791, 4428, 5770, 4790,
+6473, 496, 1081, 949, 476, 6384, 2682, 6383, 4771, 5770, 5769,
+6474, 1241, 1311, 1308, 695, 3518, 3524, 3509, 6840, 5687, 5685,
+6475, 734, 1294, 1252, 1270, 6320, 3460, 6246, 6247, 3535, 3383,
+6476, 29, 173, 172, 810, 3594, 1408, 3595, 7053, 1837, 1836,
+6477, 1242, 1312, 683, 1238, 3527, 7753, 7859, 3286, 3528, 6863,
+6478, 286, 115, 85, 843, 7703, 3623, 3852, 5882, 1914, 7693,
+6479, 226, 333, 945, 368, 4046, 7967, 8019, 4116, 4115, 5744,
+6480, 170, 807, 340, 808, 1828, 7677, 7987, 1830, 1832, 6776,
+6481, 843, 995, 1063, 431, 2391, 2608, 2607, 7071, 7486, 5912,
+6482, 953, 952, 372, 1084, 2272, 6740, 7117, 2694, 2693, 7417,
+6483, 730, 1335, 1346, 1328, 6563, 1715, 7701, 6564, 1617, 1725,
+6484, 484, 809, 965, 810, 6318, 2306, 7005, 7108, 1838, 2307,
+6485, 924, 995, 430, 998, 2392, 7485, 5884, 2402, 2606, 7487,
+6486, 77, 5, 2, 1374, 3673, 1497, 1601, 7653, 7515, 6604,
+6487, 804, 960, 339, 805, 2291, 5494, 5615, 1823, 2292, 5496,
+6488, 1342, 753, 1361, 1333, 6828, 7737, 1661, 1695, 8059, 1694,
+6489, 903, 42, 187, 41, 6655, 7209, 2078, 5752, 1565, 7625,
+6490, 187, 186, 903, 41, 1423, 2079, 2078, 7625, 5751, 5752,
+6491, 975, 973, 391, 1114, 2336, 7391, 7957, 2790, 2789, 5862,
+6492, 214, 917, 215, 69, 2107, 2106, 1451, 7079, 6986, 8041,
+6493, 1163, 1114, 975, 390, 2946, 2790, 2947, 6033, 7628, 6085,
+6494, 601, 1249, 1165, 1184, 7360, 3315, 6076, 5680, 3337, 3174,
+6495, 464, 1135, 1134, 552, 7692, 2856, 6535, 4683, 7787, 6536,
+6496, 735, 729, 1330, 732, 5315, 6498, 7982, 5314, 5304, 6499,
+6497, 1143, 1201, 1142, 557, 3085, 3084, 2880, 6886, 6633, 6883,
+6498, 1240, 710, 679, 678, 6288, 5356, 7309, 6287, 5298, 5116,
+6499, 646, 1225, 578, 644, 6627, 6081, 4998, 5022, 6083, 4994,
+6500, 1264, 1226, 617, 1257, 2985, 6808, 7227, 2984, 2986, 6629,
+6501, 1233, 1201, 1143, 557, 3238, 3085, 3236, 6632, 6633, 6886,
+6502, 1142, 556, 557, 1201, 7494, 4789, 6883, 3084, 6534, 6633,
+6503, 1319, 1356, 742, 1358, 1710, 6957, 6466, 1711, 1671, 6467,
+6504, 1309, 696, 671, 732, 6340, 5251, 6292, 6500, 5296, 5295,
+6505, 240, 37, 901, 818, 3713, 8067, 6834, 6835, 8029, 2114,
+6506, 308, 345, 859, 36, 4103, 8028, 5801, 3917, 4001, 7567,
+6507, 1132, 1230, 1199, 555, 3074, 3076, 3073, 5973, 7324, 7323,
+6508, 1016, 861, 344, 860, 2453, 6531, 5835, 2452, 1954, 6468,
+6509, 237, 817, 856, 179, 5824, 2153, 6580, 5823, 1860, 2069,
+6510, 209, 208, 914, 63, 1445, 2101, 2100, 7721, 7722, 5583,
+6511, 1055, 413, 989, 1109, 5858, 7402, 2574, 2772, 7724, 2770,
+6512, 671, 1258, 593, 696, 6269, 7521, 5092, 5251, 6341, 5148,
+6513, 975, 1114, 391, 390, 2790, 5862, 7957, 6085, 7628, 4171,
+6514, 1377, 62, 264, 265, 7573, 3786, 6709, 6710, 3788, 3790,
+6515, 1133, 564, 1134, 1230, 6965, 7637, 2853, 3075, 6966, 3223,
+6516, 371, 949, 950, 794, 6889, 2263, 6890, 7247, 2259, 2261,
+6517, 988, 412, 265, 411, 6893, 4232, 6897, 6892, 4234, 4230,
+6518, 369, 334, 792, 948, 4117, 7083, 6791, 6438, 6386, 2255,
+6519, 1309, 1258, 671, 696, 3511, 6269, 6292, 6340, 6341, 5251,
+6520, 730, 1328, 1346, 1291, 6564, 1725, 7701, 8050, 2736, 2688,
+6521, 897, 219, 75, 327, 2060, 7119, 5843, 7306, 7304, 3954,
+6522, 215, 917, 70, 69, 2106, 7067, 7068, 8041, 6986, 1593,
+6523, 559, 1201, 648, 556, 6021, 6533, 5007, 4703, 6534, 5006,
+6524, 1209, 570, 1079, 598, 7434, 8005, 3116, 6390, 4879, 6389,
+6525, 746, 706, 747, 1236, 5341, 5343, 5342, 5557, 5755, 5556,
+6526, 381, 1026, 1128, 1027, 7200, 2833, 7263, 7199, 2487, 2834,
+6527, 483, 961, 962, 233, 7396, 2299, 7398, 4452, 7811, 7812,
+6528, 936, 304, 305, 103, 7705, 3910, 7189, 7980, 3906, 3908,
+6529, 351, 872, 195, 194, 6590, 1986, 6624, 7632, 1985, 1431,
+6530, 676, 1279, 1280, 1212, 6508, 3428, 6351, 6350, 3416, 3417,
+6531, 705, 706, 746, 1236, 5201, 5341, 5309, 5757, 5755, 5557,
+6532, 581, 1279, 676, 1212, 5512, 6508, 5110, 5511, 3416, 6350,
+6533, 97, 130, 131, 932, 3650, 1484, 3651, 7755, 2141, 2140,
+6534, 308, 36, 859, 37, 3917, 7567, 5801, 3916, 1560, 5802,
+6535, 479, 951, 952, 796, 7295, 2269, 7335, 7607, 2265, 2267,
+6536, 1221, 686, 631, 630, 7060, 5141, 7151, 6730, 5140, 5034,
+6537, 479, 952, 229, 796, 7335, 6741, 4442, 7607, 2267, 7918,
+6538, 7, 783, 330, 224, 6758, 5971, 3964, 3677, 6988, 3992,
+6539, 375, 482, 494, 959, 4465, 4508, 4743, 5523, 6165, 5531,
+6540, 26, 807, 170, 169, 6139, 1828, 3589, 3587, 1827, 1405,
+6541, 340, 807, 170, 26, 7677, 1828, 7987, 3986, 6139, 3589,
+6542, 611, 1212, 581, 676, 6382, 5511, 4893, 5106, 6350, 5110,
+6543, 901, 37, 182, 818, 8067, 6423, 2075, 2114, 8029, 1861,
+6544, 35, 900, 817, 180, 6188, 2154, 5825, 6180, 2073, 1859,
+6545, 320, 356, 467, 1038, 4090, 4404, 4403, 7910, 7913, 7547,
+6546, 34, 857, 307, 35, 6051, 5521, 3915, 1558, 6052, 3914,
+6547, 320, 882, 356, 1038, 7138, 7298, 4090, 7910, 2518, 7913,
+6548, 626, 514, 1187, 1223, 4824, 5933, 7891, 7666, 6150, 3257,
+6549, 680, 1241, 625, 1223, 6701, 7618, 5119, 6255, 3280, 7619,
+6550, 844, 288, 433, 926, 7563, 4296, 7474, 2179, 7877, 5817,
+6551, 829, 262, 1373, 59, 7772, 7424, 7878, 7887, 3779, 6927,
+6552, 121, 927, 291, 290, 2129, 7029, 7027, 6858, 6455, 3868,
+6553, 261, 59, 262, 829, 3777, 3779, 3781, 8013, 7887, 7772,
+6554, 505, 589, 1193, 621, 4817, 7208, 6091, 4816, 4815, 6092,
+6555, 1334, 743, 702, 1312, 6974, 5364, 6003, 3378, 7509, 6004,
+6556, 793, 948, 476, 949, 2256, 5771, 6387, 2258, 2260, 5769,
+6557, 426, 281, 282, 840, 4275, 3841, 4276, 8039, 5696, 7166,
+6558, 1252, 734, 1255, 1294, 6246, 7379, 3336, 3460, 6320, 3461,
+6559, 999, 281, 426, 840, 5694, 4275, 7290, 2403, 5696, 8039,
+6560, 426, 840, 282, 972, 8039, 7166, 4276, 7170, 2329, 7746,
+6561, 626, 680, 625, 1223, 5120, 5119, 5042, 7666, 6255, 7619,
+6562, 924, 84, 286, 115, 6956, 3851, 5883, 2123, 3622, 7703,
+6563, 1154, 972, 569, 1161, 2915, 7171, 5789, 2938, 2937, 6238,
+6564, 427, 569, 426, 972, 4739, 4738, 4280, 6579, 7171, 7170,
+6565, 7, 783, 224, 146, 6758, 6988, 3677, 3545, 1756, 7823,
+6566, 514, 1223, 626, 513, 6150, 7666, 4824, 4568, 5543, 4823,
+6567, 1144, 557, 1143, 486, 7403, 6886, 2883, 7354, 4696, 7960,
+6568, 1202, 618, 1272, 1234, 8034, 6904, 3389, 3262, 7660, 3388,
+6569, 1221, 631, 526, 525, 7151, 4835, 7983, 7150, 4834, 4607,
+6570, 98, 131, 132, 851, 3652, 1485, 3653, 7949, 1930, 1929,
+6571, 29, 810, 172, 341, 7053, 1836, 3595, 3987, 7122, 5652,
+6572, 1272, 618, 658, 1234, 6904, 5061, 5776, 3388, 7660, 6674,
+6573, 658, 576, 602, 1234, 5059, 4861, 5060, 6674, 5600, 7853,
+6574, 346, 863, 40, 862, 7255, 7268, 4004, 7510, 1960, 8068,
+6575, 40, 863, 185, 862, 7268, 1958, 5900, 8068, 1960, 1956,
+6576, 1307, 602, 658, 677, 7447, 5060, 5774, 7253, 5107, 5109,
+6577, 184, 39, 185, 862, 7514, 8055, 1421, 1955, 6158, 1956,
+6578, 903, 244, 973, 245, 6213, 6214, 2331, 7768, 3730, 7770,
+6579, 185, 184, 902, 39, 1421, 2077, 2076, 8055, 7514, 7036,
+6580, 39, 346, 40, 862, 4005, 4004, 1563, 6158, 7510, 8068,
+6581, 1118, 1017, 1119, 380, 2804, 2806, 2808, 7860, 7096, 5954,
+6582, 241, 38, 39, 819, 3716, 1562, 3717, 6149, 5925, 7146,
+6583, 64, 322, 65, 887, 3945, 3944, 1588, 6192, 6191, 7449,
+6584, 195, 825, 51, 50, 1876, 7804, 7802, 6626, 7580, 1574,
+6585, 825, 252, 253, 50, 6720, 3754, 6719, 7580, 3750, 3752,
+6586, 1131, 555, 1199, 579, 8061, 7323, 3072, 6748, 4786, 6747,
+6587, 1023, 1124, 457, 1125, 2822, 8002, 5697, 2824, 2826, 6276,
+6588, 253, 51, 825, 50, 3753, 7804, 6719, 3752, 1574, 7580,
+6589, 185, 39, 40, 862, 8055, 1563, 5900, 1956, 6158, 8068,
+6590, 600, 1301, 1261, 1303, 7869, 3512, 7639, 7943, 3489, 3516,
+6591, 195, 50, 51, 873, 6626, 1574, 7802, 1988, 6625, 7829,
+6592, 496, 949, 371, 476, 6383, 6889, 4513, 4771, 5769, 4429,
+6593, 811, 173, 29, 810, 1839, 3594, 7052, 1841, 1837, 7053,
+6594, 262, 60, 263, 830, 3780, 3782, 3784, 5913, 5688, 5691,
+6595, 1373, 262, 830, 60, 7424, 5913, 6374, 6732, 3780, 5688,
+6596, 264, 207, 913, 206, 7809, 2098, 6712, 6934, 1443, 2099,
+6597, 264, 61, 206, 263, 3785, 6680, 6934, 3787, 3783, 5690,
+6598, 352, 874, 51, 873, 7270, 7280, 4017, 7855, 1993, 7829,
+6599, 51, 315, 352, 873, 3930, 4062, 4017, 7829, 7781, 7855,
+6600, 657, 1268, 1303, 1302, 7941, 3490, 7940, 7752, 3485, 3531,
+6601, 1152, 1151, 558, 1204, 2907, 8038, 7220, 3094, 3093, 7699,
+6602, 526, 421, 1162, 420, 4606, 6063, 5721, 4605, 4261, 8032,
+6603, 661, 1303, 715, 657, 7045, 5867, 5227, 5069, 7940, 5226,
+6604, 661, 600, 1261, 1303, 5067, 7639, 6725, 7045, 7943, 3516,
+6605, 51, 50, 315, 873, 1574, 3931, 3930, 7829, 6625, 7781,
+6606, 195, 873, 51, 196, 1988, 7829, 7802, 1432, 1989, 7803,
+6607, 792, 334, 793, 948, 7083, 6385, 1787, 2255, 6386, 2256,
+6608, 468, 357, 1040, 321, 4406, 7395, 7411, 4405, 4091, 7412,
+6609, 62, 885, 207, 884, 7281, 2024, 7622, 7283, 2026, 2022,
+6610, 207, 884, 206, 61, 2022, 2021, 1443, 7888, 6651, 6680,
+6611, 901, 37, 240, 38, 8067, 3713, 6834, 6163, 1561, 3714,
+6612, 62, 884, 61, 357, 7283, 6651, 1585, 4026, 6652, 4027,
+6613, 62, 884, 207, 61, 7283, 2022, 7622, 1585, 6651, 7888,
+6614, 1363, 1366, 778, 1370, 1606, 7794, 7426, 1605, 1607, 6993,
+6615, 1277, 1333, 713, 740, 2698, 7048, 7017, 7408, 8000, 5359,
+6616, 545, 445, 1008, 444, 4665, 7173, 7583, 4664, 4334, 5768,
+6617, 604, 657, 614, 1268, 5055, 5057, 5005, 7871, 7941, 6470,
+6618, 397, 906, 980, 979, 6545, 2350, 6509, 6544, 2347, 2584,
+6619, 218, 895, 73, 896, 2055, 7862, 6097, 2057, 2059, 7322,
+6620, 217, 72, 218, 895, 5537, 7198, 1454, 2054, 6684, 2055,
+6621, 406, 514, 405, 1106, 4567, 4566, 4216, 6396, 5934, 6644,
+6622, 554, 1203, 560, 597, 7662, 6803, 4706, 4844, 7786, 4845,
+6623, 703, 721, 1355, 1331, 5248, 8053, 7780, 6942, 6554, 1603,
+6624, 73, 72, 326, 895, 1596, 3953, 3952, 7862, 6684, 6683,
+6625, 218, 72, 73, 895, 7198, 1596, 6097, 2055, 6684, 7862,
+6626, 466, 1036, 1138, 1037, 7352, 2863, 6413, 7236, 2517, 2864,
+6627, 756, 1357, 713, 1345, 6283, 7047, 5380, 7934, 1683, 7018,
+6628, 320, 882, 60, 356, 7138, 6733, 3941, 4090, 7298, 4024,
+6629, 25, 233, 168, 805, 3695, 8066, 3585, 7885, 7952, 1822,
+6630, 357, 883, 320, 1039, 6653, 6673, 4067, 7549, 2521, 7911,
+6631, 1043, 486, 1144, 1042, 6716, 7354, 2882, 2535, 7936, 2881,
+6632, 991, 270, 417, 271, 7132, 4247, 7621, 7217, 3808, 4248,
+6633, 251, 906, 250, 48, 7059, 7021, 3748, 3746, 7953, 3744,
+6634, 824, 906, 251, 48, 2193, 7059, 7008, 7009, 7953, 3746,
+6635, 1043, 359, 1044, 470, 7624, 6483, 2538, 6715, 4411, 7147,
+6636, 251, 906, 397, 250, 7059, 6545, 4188, 3748, 7021, 4187,
+6637, 980, 906, 397, 251, 2350, 6545, 6509, 7058, 7059, 4188,
+6638, 658, 602, 1307, 1234, 5060, 7447, 5774, 6674, 7853, 3507,
+6639, 282, 840, 922, 972, 7166, 2221, 7165, 7746, 2329, 2328,
+6640, 433, 288, 844, 432, 4296, 7563, 7474, 4298, 4294, 7473,
+6641, 155, 334, 792, 14, 6806, 7083, 1783, 3561, 3974, 8069,
+6642, 848, 294, 295, 93, 7370, 3880, 7464, 7465, 3876, 3878,
+6643, 155, 792, 154, 14, 1783, 1782, 1390, 3561, 8069, 3562,
+6644, 792, 334, 227, 14, 7083, 4047, 6790, 8069, 3974, 3682,
+6645, 439, 295, 848, 294, 4315, 7464, 7369, 4314, 3880, 7370,
+6646, 340, 808, 27, 170, 6776, 6323, 3985, 7987, 1830, 3591,
+6647, 440, 541, 439, 1003, 4652, 4651, 4319, 7498, 5707, 6941,
+6648, 273, 917, 272, 70, 7848, 6985, 3814, 3812, 7067, 3810,
+6649, 809, 234, 484, 808, 6319, 4454, 6318, 1835, 6324, 7141,
+6650, 548, 1183, 1009, 1071, 6802, 3033, 5664, 5665, 3050, 2636,
+6651, 1011, 1010, 450, 855, 2638, 6433, 7101, 2436, 2434, 8047,
+6652, 639, 1246, 1099, 1186, 6040, 3300, 6041, 6517, 3299, 3029,
+6653, 85, 116, 287, 843, 3624, 6959, 3854, 7693, 1913, 6960,
+6654, 1090, 571, 375, 1091, 7313, 4748, 5529, 2719, 7975, 8054,
+6655, 908, 254, 255, 52, 6878, 3760, 7730, 7274, 3756, 3758,
+6656, 462, 555, 1131, 579, 4691, 8061, 5782, 4784, 4786, 6748,
+6657, 152, 13, 153, 790, 3559, 3558, 1388, 1776, 5693, 1777,
+6658, 462, 555, 1132, 1131, 4691, 5973, 7496, 5782, 8061, 2847,
+6659, 908, 52, 255, 197, 7274, 3758, 7730, 2088, 7269, 6450,
+6660, 198, 53, 54, 876, 6451, 1577, 7714, 1997, 7715, 7713,
+6661, 792, 227, 154, 14, 6790, 7499, 1782, 8069, 3682, 3562,
+6662, 851, 299, 444, 300, 6896, 4329, 5767, 7951, 3895, 4330,
+6663, 925, 287, 288, 117, 5874, 3859, 7561, 2125, 7946, 7562,
+6664, 529, 424, 1097, 423, 4615, 5627, 5722, 4614, 4270, 5723,
+6665, 482, 803, 802, 958, 6164, 1817, 7317, 6001, 2286, 2285,
+6666, 232, 482, 803, 338, 4448, 6164, 5651, 4079, 4449, 6280,
+6667, 445, 301, 446, 852, 4333, 4335, 4337, 7948, 7223, 7779,
+6668, 482, 958, 802, 374, 6001, 2285, 7317, 4500, 6000, 6645,
+6669, 482, 374, 802, 338, 4500, 6645, 7317, 4449, 4127, 7105,
+6670, 460, 348, 1022, 312, 4383, 7905, 5633, 4382, 4101, 6090,
+6671, 1023, 1124, 460, 457, 2822, 5634, 5632, 5697, 8002, 4384,
+6672, 375, 960, 1090, 1091, 5524, 2715, 5529, 8054, 2717, 2719,
+6673, 131, 299, 932, 851, 8070, 5742, 2140, 1930, 6896, 2213,
+6674, 26, 233, 340, 807, 3694, 4053, 3986, 6139, 8022, 7677,
+6675, 182, 901, 38, 37, 2075, 6163, 6979, 6423, 8067, 1561,
+6676, 617, 498, 1264, 608, 4911, 6010, 7227, 4910, 4884, 6011,
+6677, 1264, 1292, 1315, 608, 3517, 3533, 3532, 6011, 6058, 6057,
+6678, 1250, 642, 1167, 1172, 5728, 5729, 3294, 3317, 6254, 2969,
+6679, 851, 300, 98, 299, 7951, 3893, 7949, 6896, 3895, 3891,
+6680, 350, 47, 870, 48, 4013, 6781, 6780, 4012, 1571, 6995,
+6681, 1024, 1126, 370, 1025, 2827, 7648, 6739, 2481, 2828, 7966,
+6682, 1221, 525, 1110, 524, 7150, 7357, 3180, 7152, 4603, 5936,
+6683, 131, 299, 97, 932, 8070, 3890, 3651, 2140, 5742, 7755,
+6684, 1317, 685, 1306, 1335, 6700, 6204, 3362, 3283, 6206, 3357,
+6685, 1110, 1103, 1219, 523, 2775, 3166, 3165, 6599, 6601, 7702,
+6686, 98, 299, 131, 851, 3891, 8070, 3652, 7949, 6896, 1930,
+6687, 92, 125, 929, 124, 3640, 2134, 6938, 3639, 1478, 2135,
+6688, 890, 212, 67, 889, 2039, 6801, 7243, 2041, 2037, 7237,
+6689, 182, 37, 38, 860, 6423, 1561, 6979, 1949, 5804, 6530,
+6690, 1107, 508, 509, 1102, 6017, 4551, 6971, 2927, 6991, 6989,
+6691, 131, 299, 98, 97, 8070, 3891, 3652, 3651, 3890, 1547,
+6692, 1307, 602, 1233, 1234, 7447, 7404, 3505, 3507, 7853, 3241,
+6693, 757, 731, 711, 1337, 5382, 5293, 5383, 6555, 7466, 7647,
+6694, 1073, 939, 478, 367, 2656, 7801, 7644, 7646, 6752, 4437,
+6695, 157, 156, 16, 794, 1392, 3566, 3565, 1789, 1788, 5960,
+6696, 435, 291, 846, 927, 4303, 7028, 7348, 6456, 7029, 2131,
+6697, 1287, 731, 714, 722, 6930, 5291, 7667, 7821, 5294, 5255,
+6698, 478, 939, 1073, 940, 7801, 2656, 7644, 5773, 2233, 2657,
+6699, 363, 1052, 474, 475, 5939, 6417, 4422, 4494, 5941, 4502,
+6700, 1075, 1207, 603, 575, 3105, 6220, 5929, 5892, 7078, 5004,
+6701, 627, 1224, 1262, 1245, 6315, 3501, 6243, 6245, 3298, 3354,
+6702, 1073, 1205, 1153, 497, 3098, 3097, 3044, 7645, 7766, 7765,
+6703, 943, 366, 1075, 942, 5888, 7963, 2664, 2242, 5887, 2663,
+6704, 550, 1139, 559, 467, 7421, 6929, 4702, 4679, 7906, 4701,
+6705, 626, 1223, 1187, 1245, 7666, 3257, 7891, 8071, 3318, 3297,
+6706, 1011, 1072, 385, 1158, 2800, 7582, 7541, 2929, 2928, 7596,
+6707, 1100, 1184, 1163, 500, 3024, 3023, 2961, 7517, 6843, 6023,
+6708, 474, 475, 1153, 497, 4502, 7615, 7763, 4515, 4514, 7765,
+6709, 188, 821, 43, 42, 1867, 8036, 5778, 5779, 7210, 1566,
+6710, 393, 392, 1056, 503, 4177, 7384, 7720, 4533, 4531, 7382,
+6711, 1265, 1273, 746, 752, 3393, 5558, 5852, 6394, 6901, 5362,
+6712, 1013, 454, 364, 328, 5851, 4441, 6060, 5849, 4434, 4098,
+6713, 1115, 475, 367, 497, 7616, 4518, 6753, 7799, 4514, 4726,
+6714, 1056, 503, 1222, 504, 7382, 6169, 3183, 6588, 4536, 6587,
+6715, 1140, 490, 559, 467, 6128, 4700, 6007, 7545, 4485, 4701,
+6716, 559, 1139, 1140, 467, 6929, 2871, 6007, 4701, 7906, 7545,
+6717, 1253, 688, 689, 588, 7376, 5179, 7123, 7125, 5178, 5153,
+6718, 660, 722, 1286, 687, 5253, 7844, 6068, 5145, 5254, 6069,
+6719, 59, 356, 60, 882, 4025, 4024, 1583, 6928, 7298, 6733,
+6720, 935, 1071, 448, 1009, 2635, 5666, 6123, 2430, 2636, 5663,
+6721, 580, 651, 496, 1082, 5045, 5020, 4792, 8060, 7538, 6338,
+6722, 627, 1223, 626, 1245, 6244, 7666, 4937, 6245, 3318, 8071,
+6723, 473, 554, 558, 1151, 4688, 4744, 4698, 7110, 7429, 8038,
+6724, 1229, 553, 600, 552, 7933, 4852, 7868, 8052, 4788, 4853,
+6725, 1295, 719, 1325, 1280, 7455, 6736, 3274, 3422, 8048, 3421,
+6726, 697, 719, 1295, 1280, 5242, 7455, 7456, 6356, 8048, 3422,
+6727, 595, 631, 1284, 664, 4838, 6569, 7883, 5076, 5075, 6571,
+6728, 1243, 521, 1111, 1182, 6638, 6822, 3290, 3359, 7148, 3019,
+6729, 627, 1245, 591, 1224, 6245, 7508, 5041, 6315, 3298, 6976,
+6730, 1111, 1103, 416, 522, 2780, 7115, 6167, 6156, 6157, 4593,
+6731, 1111, 414, 1055, 521, 6020, 5857, 2779, 6822, 4589, 7923,
+6732, 951, 1082, 496, 1083, 2687, 6338, 7296, 2690, 2692, 6339,
+6733, 1211, 651, 580, 1082, 6199, 5045, 8057, 3122, 7538, 8060,
+6734, 281, 79, 921, 280, 3836, 7749, 5695, 3838, 3835, 6636,
+6735, 305, 104, 306, 855, 3909, 3911, 3913, 7979, 6945, 6430,
+6736, 627, 1245, 516, 591, 6245, 7507, 4936, 5041, 7508, 4825,
+6737, 890, 68, 891, 360, 7428, 7919, 2044, 7246, 4032, 6642,
+6738, 436, 292, 437, 928, 4306, 4308, 4310, 7179, 7711, 7178,
+6739, 846, 436, 1000, 928, 7167, 7177, 2416, 2181, 7179, 2407,
+6740, 891, 68, 890, 213, 7919, 7428, 2044, 2042, 6270, 2040,
+6741, 710, 1289, 1240, 1256, 7279, 3450, 6288, 7277, 3449, 3349,
+6742, 121, 846, 122, 291, 1920, 1919, 1475, 7027, 7028, 7356,
+6743, 960, 1091, 375, 376, 2717, 8054, 5524, 5601, 7610, 4450,
+6744, 587, 663, 609, 1269, 5170, 5073, 4918, 6036, 6857, 6885,
+6745, 572, 1091, 571, 1215, 7974, 7975, 4794, 7570, 3147, 6841,
+6746, 821, 246, 43, 245, 7643, 3731, 8036, 7769, 3733, 3729,
+6747, 111, 922, 282, 110, 2119, 7165, 7155, 1464, 2120, 7164,
+6748, 111, 110, 282, 81, 1464, 7164, 7155, 3615, 3614, 3840,
+6749, 730, 1291, 1346, 762, 8050, 2688, 7701, 5405, 6445, 6921,
+6750, 1163, 1184, 1188, 501, 3023, 3173, 3036, 6032, 6660, 7631,
+6751, 592, 520, 1185, 519, 4828, 6361, 7657, 4827, 4587, 7427,
+6752, 448, 1071, 935, 854, 5666, 2635, 6123, 6124, 2634, 2216,
+6753, 698, 684, 1313, 1307, 5284, 7731, 6581, 5775, 7732, 1734,
+6754, 293, 91, 92, 124, 3872, 1541, 3873, 7789, 3638, 3639,
+6755, 510, 1181, 623, 1179, 6400, 6846, 4926, 5658, 3164, 8037,
+6756, 492, 566, 1198, 1128, 4730, 6703, 7882, 7827, 7638, 3070,
+6757, 1340, 763, 1329, 754, 5969, 6611, 1680, 7757, 5407, 7884,
+6758, 303, 304, 137, 102, 3907, 7972, 7695, 3903, 3905, 3662,
+6759, 516, 1245, 627, 515, 7507, 6245, 4936, 4574, 7489, 4935,
+6760, 656, 654, 1266, 720, 5054, 6251, 5785, 5245, 5247, 7362,
+6761, 626, 1245, 1187, 515, 8071, 3297, 7891, 4934, 7489, 7490,
+6762, 1109, 520, 412, 519, 6362, 4585, 6522, 6524, 4587, 4583,
+6763, 736, 1326, 759, 762, 5979, 5981, 5446, 5418, 6446, 5413,
+6764, 627, 1245, 626, 515, 6245, 8071, 4937, 4935, 7489, 4934,
+6765, 1256, 672, 688, 1254, 7612, 5151, 7605, 3447, 6849, 7375,
+6766, 403, 512, 402, 983, 4561, 4559, 4207, 6478, 7315, 7232,
+6767, 1086, 481, 562, 565, 5625, 4712, 6377, 6378, 4721, 4723,
+6768, 480, 1085, 954, 1084, 5622, 2699, 5605, 7792, 2701, 2696,
+6769, 957, 481, 562, 956, 7242, 4712, 6129, 2284, 5623, 6917,
+6770, 374, 481, 562, 957, 4495, 4712, 4711, 6646, 7242, 6129,
+6771, 1085, 565, 611, 577, 6380, 4894, 6381, 7810, 4787, 4892,
+6772, 438, 1004, 847, 929, 6953, 2418, 7380, 7366, 2417, 2182,
+6773, 50, 49, 194, 907, 1573, 7325, 7330, 7331, 7326, 2087,
+6774, 449, 1071, 448, 854, 5809, 5666, 4346, 6618, 2634, 6124,
+6775, 1198, 566, 492, 619, 6703, 4730, 7882, 6704, 4915, 4914,
+6776, 461, 1027, 381, 1128, 6568, 7199, 4387, 6620, 2834, 7263,
+6777, 826, 1059, 909, 402, 2590, 2592, 2164, 7248, 7231, 7230,
+6778, 10, 332, 11, 150, 3969, 3968, 1503, 3552, 8027, 3555,
+6779, 193, 871, 870, 48, 1982, 1984, 1980, 6585, 6586, 6995,
+6780, 582, 458, 1122, 455, 4798, 6301, 7838, 4854, 4377, 6662,
+6781, 824, 48, 194, 193, 7009, 6584, 1873, 1874, 6585, 1430,
+6782, 303, 136, 935, 853, 7696, 2147, 7697, 7991, 1933, 2188,
+6783, 1310, 673, 701, 699, 6714, 5188, 7955, 6540, 5180, 5244,
+6784, 691, 1251, 749, 741, 7418, 7497, 5348, 5350, 7598, 5351,
+6785, 518, 519, 1160, 411, 4584, 6134, 5828, 4580, 4582, 7739,
+6786, 1022, 348, 460, 455, 7905, 4383, 5633, 5747, 4365, 4459,
+6787, 984, 827, 403, 404, 2361, 6557, 6476, 5499, 5977, 4210,
+6788, 591, 673, 627, 1224, 5096, 5095, 5041, 6976, 6316, 6315,
+6789, 1002, 1065, 1066, 434, 2781, 2650, 2619, 8024, 6422, 7341,
+6790, 1308, 701, 680, 695, 6274, 5187, 6272, 5685, 5261, 5260,
+6791, 680, 1241, 1308, 695, 6701, 3509, 6272, 5260, 6840, 5685,
+6792, 276, 1062, 919, 994, 7931, 2605, 6026, 7912, 2649, 2389,
+6793, 778, 744, 1363, 1372, 5469, 7743, 7426, 6994, 7830, 1630,
+6794, 657, 600, 661, 1303, 5056, 5067, 5069, 7940, 7943, 7045,
+6795, 150, 332, 788, 787, 8027, 6031, 1770, 1768, 7984, 1772,
+6796, 1219, 1103, 522, 523, 3166, 6157, 6239, 7702, 6601, 4597,
+6797, 572, 1091, 1092, 376, 7974, 2722, 7555, 4752, 7610, 7609,
+6798, 276, 994, 423, 422, 7912, 6689, 4265, 4263, 6687, 4267,
+6799, 1256, 700, 688, 672, 7276, 5183, 7605, 7612, 5182, 5151,
+6800, 1067, 443, 544, 444, 8026, 4661, 7778, 7777, 4331, 4662,
+6801, 1062, 994, 276, 422, 2649, 7912, 7931, 6065, 6687, 4263,
+6802, 1062, 422, 1162, 1159, 6065, 6066, 2940, 2933, 6688, 2971,
+6803, 150, 332, 11, 788, 8027, 3968, 3555, 1770, 6031, 7668,
+6804, 1218, 1162, 527, 1159, 3177, 6307, 6494, 3185, 2971, 6923,
+6805, 1002, 1064, 432, 844, 2614, 5839, 5837, 2413, 2611, 7473,
+6806, 1002, 536, 1155, 1065, 5838, 6354, 2919, 2781, 7476, 2918,
+6807, 527, 422, 528, 1159, 4609, 4611, 4613, 6923, 6688, 5708,
+6808, 307, 1005, 280, 365, 5520, 6352, 4000, 4106, 5899, 4107,
+6809, 561, 1147, 551, 1202, 6114, 6115, 4709, 6825, 3088, 7736,
+6810, 88, 845, 120, 290, 7161, 1917, 3631, 3863, 6737, 6833,
+6811, 846, 1054, 1000, 436, 2568, 2570, 2416, 7167, 7347, 7177,
+6812, 846, 928, 122, 292, 2181, 2133, 1919, 7168, 7711, 7355,
+6813, 1165, 547, 548, 1009, 5730, 4675, 6193, 2951, 5732, 5664,
+6814, 426, 281, 999, 365, 4275, 5694, 7290, 4277, 4108, 5898,
+6815, 449, 854, 448, 304, 6618, 6124, 4346, 4344, 6126, 4342,
+6816, 856, 237, 106, 343, 6580, 3703, 7817, 8030, 3994, 3993,
+6817, 1275, 666, 1274, 610, 6342, 5762, 3263, 5617, 5079, 5763,
+6818, 1177, 581, 716, 651, 5510, 5230, 7909, 7440, 5021, 5233,
+6819, 106, 105, 856, 343, 1555, 7925, 7817, 3993, 3995, 8030,
+6820, 1263, 597, 554, 585, 7785, 4844, 7971, 6358, 4846, 4805,
+6821, 307, 857, 858, 35, 5521, 1945, 5519, 3914, 6052, 6179,
+6822, 1178, 676, 611, 653, 6349, 5106, 5909, 6360, 5105, 5036,
+6823, 846, 435, 436, 291, 7348, 4307, 7167, 7028, 4303, 4305,
+6824, 37, 818, 239, 36, 8029, 7342, 3711, 1560, 7363, 3710,
+6825, 700, 672, 1256, 710, 5182, 7612, 7276, 5312, 5311, 7277,
+6826, 1024, 349, 869, 313, 5508, 7698, 2477, 7635, 4100, 7634,
+6827, 345, 365, 456, 1014, 4109, 4369, 4368, 7194, 7192, 6116,
+6828, 999, 281, 921, 365, 5694, 5695, 2404, 5898, 4108, 5897,
+6829, 1211, 607, 580, 651, 6198, 4880, 8057, 6199, 5046, 5045,
+6830, 607, 662, 1276, 717, 5071, 7791, 5994, 5231, 5235, 5962,
+6831, 570, 598, 1209, 610, 4879, 6390, 7434, 4890, 4889, 5618,
+6832, 1079, 598, 570, 477, 6389, 4879, 8005, 7915, 4849, 4741,
+6833, 369, 598, 1079, 477, 4848, 6389, 7927, 4433, 4849, 7915,
+6834, 1372, 772, 744, 1356, 6475, 5466, 7830, 1635, 6958, 7614,
+6835, 280, 1005, 921, 365, 6352, 2423, 6636, 4107, 5899, 5897,
+6836, 669, 697, 1281, 653, 5250, 6357, 6049, 5086, 5174, 5829,
+6837, 56, 202, 879, 57, 7495, 2007, 7895, 1580, 6242, 7900,
+6838, 1299, 699, 1342, 740, 7661, 6541, 3142, 7409, 5185, 6829,
+6839, 1240, 1289, 710, 1270, 3450, 7279, 6288, 3384, 3207, 6812,
+6840, 184, 861, 39, 862, 1953, 6144, 7514, 1955, 1957, 6158,
+6841, 1327, 1344, 727, 1314, 1728, 7837, 7836, 3126, 2727, 7806,
+6842, 409, 262, 986, 408, 4223, 7771, 8015, 4225, 4221, 6948,
+6843, 414, 267, 832, 413, 4238, 5549, 5859, 4240, 4236, 5547,
+6844, 1354, 767, 770, 756, 6365, 5454, 6364, 6282, 5453, 5432,
+6845, 183, 38, 184, 861, 5923, 5924, 1420, 1952, 6146, 1953,
+6846, 1361, 1367, 779, 1366, 1619, 6538, 7832, 1620, 1611, 6539,
+6847, 228, 156, 16, 15, 5990, 3566, 3684, 3685, 3563, 1508,
+6848, 881, 58, 880, 203, 5597, 5596, 2014, 2012, 6171, 2010,
+6849, 689, 1289, 700, 688, 7365, 7278, 5193, 5179, 7377, 5183,
+6850, 1343, 770, 1354, 1336, 6969, 6364, 1673, 1718, 7814, 1704,
+6851, 66, 211, 67, 833, 6335, 7446, 1590, 6333, 1892, 6800,
+6852, 49, 48, 314, 871, 1572, 3929, 3928, 6622, 6586, 6621,
+6853, 428, 996, 429, 532, 7819, 5716, 4286, 4622, 5718, 4623,
+6854, 912, 830, 262, 409, 2199, 5913, 7425, 8016, 5886, 4223,
+6855, 656, 655, 681, 1191, 5053, 5123, 5125, 5787, 7865, 7864,
+6856, 1195, 632, 644, 655, 6182, 5048, 7055, 7870, 5047, 5049,
+6857, 70, 917, 272, 69, 7067, 6985, 3810, 1593, 6986, 3809,
+6858, 873, 1028, 351, 315, 2489, 6565, 6623, 7781, 5998, 4085,
+6859, 194, 48, 49, 871, 6584, 1572, 7325, 1983, 6586, 6622,
+6860, 788, 332, 943, 787, 6031, 8049, 2241, 1772, 7984, 2240,
+6861, 1192, 1246, 637, 707, 3307, 5879, 6112, 5800, 6113, 5205,
+6862, 383, 332, 943, 788, 4147, 8049, 5702, 5703, 6031, 2241,
+6863, 1255, 747, 748, 1192, 5937, 5345, 7378, 3335, 5938, 6096,
+6864, 943, 332, 383, 366, 8049, 4147, 5702, 5888, 4111, 4148,
+6865, 382, 225, 942, 366, 4143, 7113, 7112, 4145, 4112, 5887,
+6866, 1112, 634, 537, 1065, 7468, 4959, 7467, 2783, 7477, 6420,
+6867, 537, 536, 1065, 634, 4640, 7476, 6420, 4959, 4958, 7477,
+6868, 925, 116, 287, 117, 2126, 6959, 5874, 2125, 1470, 7946,
+6869, 726, 1289, 1340, 745, 7364, 3193, 5968, 5338, 7924, 5970,
+6870, 243, 390, 977, 975, 4166, 6084, 6861, 6528, 6085, 2344,
+6871, 467, 466, 1139, 1037, 4477, 7544, 7906, 7907, 7236, 2866,
+6872, 813, 236, 342, 31, 7850, 4083, 5916, 6208, 3701, 3989,
+6873, 32, 236, 176, 31, 3700, 8072, 3602, 1524, 3701, 3599,
+6874, 814, 236, 176, 32, 5613, 8072, 1848, 7107, 3700, 3602,
+6875, 1361, 1366, 779, 753, 1620, 6539, 7832, 7737, 6415, 5484,
+6876, 405, 258, 259, 985, 4211, 3772, 4212, 6109, 7445, 6111,
+6877, 793, 949, 228, 794, 2258, 6894, 6409, 1790, 2259, 5959,
+6878, 1312, 683, 694, 1242, 7753, 5184, 7947, 3527, 7859, 6104,
+6879, 538, 1000, 539, 1171, 7373, 7087, 4647, 6312, 2978, 7594,
+6880, 61, 884, 206, 883, 6651, 2021, 6680, 6654, 2023, 2019,
+6881, 176, 236, 813, 31, 8072, 7850, 1846, 3599, 3701, 6208,
+6882, 176, 236, 814, 813, 8072, 5613, 1848, 1846, 7850, 1850,
+6883, 44, 312, 867, 866, 3925, 6399, 6397, 5588, 7956, 1972,
+6884, 261, 829, 260, 58, 8013, 6760, 3778, 3776, 7994, 3774,
+6885, 261, 58, 59, 829, 3776, 1582, 3777, 8013, 7994, 7887,
+6886, 868, 312, 45, 349, 7590, 3924, 6772, 5509, 4059, 4011,
+6887, 1153, 1052, 474, 1051, 2909, 6417, 7763, 2908, 2562, 6418,
+6888, 312, 1022, 866, 348, 6090, 2470, 7956, 4101, 7905, 5589,
+6889, 698, 1307, 1313, 1317, 5775, 1734, 6581, 6583, 3367, 3411,
+6890, 987, 411, 264, 410, 7969, 4229, 7185, 5921, 4231, 4227,
+6891, 1023, 312, 349, 457, 5698, 4059, 5507, 5697, 4372, 4371,
+6892, 174, 173, 29, 811, 1409, 3594, 3596, 1840, 1839, 7052,
+6893, 668, 1313, 721, 684, 6551, 6552, 5282, 5133, 7731, 5332,
+6894, 1242, 1238, 624, 1181, 3286, 6848, 7480, 3285, 3272, 5576,
+6895, 264, 62, 207, 61, 3786, 7622, 7809, 3785, 1585, 7888,
+6896, 1022, 867, 1023, 312, 2471, 2473, 2475, 6090, 6399, 5698,
+6897, 1321, 750, 675, 1324, 7258, 5353, 5987, 1738, 7904, 5989,
+6898, 44, 312, 866, 348, 3925, 7956, 5588, 4008, 4101, 5589,
+6899, 539, 1170, 540, 637, 7131, 7126, 4650, 4967, 5880, 4968,
+6900, 447, 853, 934, 302, 5725, 2215, 7272, 4338, 7992, 7216,
+6901, 1253, 589, 1239, 588, 7124, 7207, 3328, 7125, 4818, 8009,
+6902, 505, 588, 504, 1239, 4814, 4813, 4539, 6313, 8009, 6314,
+6903, 580, 607, 1176, 598, 4880, 8035, 7603, 4862, 4881, 6899,
+6904, 505, 588, 1239, 589, 4814, 8009, 6313, 4817, 4818, 7207,
+6905, 306, 937, 140, 105, 6429, 2151, 6428, 3912, 7926, 3668,
+6906, 548, 448, 449, 1071, 4674, 4346, 4847, 5665, 5666, 5809,
+6907, 108, 839, 78, 107, 1905, 6505, 3609, 1461, 1906, 3608,
+6908, 1040, 884, 357, 1039, 2524, 6652, 7395, 2526, 2522, 7549,
+6909, 208, 885, 63, 886, 2025, 7291, 7722, 2027, 2029, 6185,
+6910, 1034, 464, 1033, 354, 7707, 7691, 2508, 7528, 4394, 7525,
+6911, 1357, 1333, 713, 1345, 1693, 7048, 7047, 1683, 1713, 7018,
+6912, 647, 552, 1230, 1261, 5002, 6967, 6560, 5540, 7773, 3350,
+6913, 318, 465, 1034, 354, 4396, 7708, 7767, 4088, 4397, 7528,
+6914, 1033, 464, 317, 354, 7691, 4395, 7327, 7525, 4394, 4064,
diff --git a/elastic-tube-3d/solid-calculix/clean.sh b/elastic-tube-3d/solid-calculix/clean.sh
new file mode 100755
index 000000000..e93f04f3c
--- /dev/null
+++ b/elastic-tube-3d/solid-calculix/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_calculix .
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/config.yml b/elastic-tube-3d/solid-calculix/config.yml
similarity index 54%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/config.yml
rename to elastic-tube-3d/solid-calculix/config.yml
index 597b03e44..43c524a66 100644
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/config.yml
+++ b/elastic-tube-3d/solid-calculix/config.yml
@@ -3,8 +3,8 @@ participants:
interfaces:
- nodes-mesh-with-connectivity: Calculix_Mesh
patch: interface
- read-data: [Forces0]
- write-data: [DisplacementDeltas0]
+ read-data: [Force]
+ write-data: [DisplacementDelta]
-precice-config-file: ./precice-config.xml
+precice-config-file: ../precice-config.xml
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/inlet.nam b/elastic-tube-3d/solid-calculix/inlet.nam
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Solid/inlet.nam
rename to elastic-tube-3d/solid-calculix/inlet.nam
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/interface.nam b/elastic-tube-3d/solid-calculix/interface.nam
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Solid/interface.nam
rename to elastic-tube-3d/solid-calculix/interface.nam
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/interface.sur b/elastic-tube-3d/solid-calculix/interface.sur
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Solid/interface.sur
rename to elastic-tube-3d/solid-calculix/interface.sur
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/outlet.nam b/elastic-tube-3d/solid-calculix/outlet.nam
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Solid/outlet.nam
rename to elastic-tube-3d/solid-calculix/outlet.nam
diff --git a/elastic-tube-3d/solid-calculix/run.sh b/elastic-tube-3d/solid-calculix/run.sh
new file mode 100755
index 000000000..5f1ff6813
--- /dev/null
+++ b/elastic-tube-3d/solid-calculix/run.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+export OMP_NUM_THREADS=1
+export CCX_NPROC_EQUATION_SOLVER=1
+ccx_preCICE -i tube -precice-participant Calculix
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/tube.inp b/elastic-tube-3d/solid-calculix/tube.inp
old mode 100755
new mode 100644
similarity index 62%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Solid/tube.inp
rename to elastic-tube-3d/solid-calculix/tube.inp
index 35d724817..69b1209a5
--- a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/tube.inp
+++ b/elastic-tube-3d/solid-calculix/tube.inp
@@ -1,9 +1,9 @@
-*INCLUDE, INPUT=Solid/all.msh
-*INCLUDE, INPUT=Solid/inlet.nam
-*INCLUDE, INPUT=Solid/outlet.nam
-*INCLUDE, INPUT=Solid/wall.nam
-*INCLUDE, INPUT=Solid/interface.nam
-*INCLUDE, INPUT=Solid/interface.sur
+*INCLUDE, INPUT=all.msh
+*INCLUDE, INPUT=inlet.nam
+*INCLUDE, INPUT=outlet.nam
+*INCLUDE, INPUT=wall.nam
+*INCLUDE, INPUT=interface.nam
+*INCLUDE, INPUT=interface.sur
*MATERIAL, Name=EL
*ELASTIC
300000.0, 0.3
diff --git a/FSI/3D_Tube/OpenFOAM-CalculiX/Solid/wall.nam b/elastic-tube-3d/solid-calculix/wall.nam
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/3D_Tube/OpenFOAM-CalculiX/Solid/wall.nam
rename to elastic-tube-3d/solid-calculix/wall.nam
diff --git a/flow-over-heated-plate-nearest-projection/README.md b/flow-over-heated-plate-nearest-projection/README.md
new file mode 100644
index 000000000..29a010d9e
--- /dev/null
+++ b/flow-over-heated-plate-nearest-projection/README.md
@@ -0,0 +1,72 @@
+---
+title: Flow over heated plate nearest projection
+permalink: tutorials-flow-over-heated-plate-nearest-projection.html
+keywords: OpenFOAM, nearest-projection, CHT
+summary: This tutorial introduces an example simulation setup for a nearest-projection mapping. At the moment, it only contains an example with the OpenFOAM adapter. The demonstrated "flow over a heated plate" scenario is exactly the same as in the `buoyantPimpleFoam-laplacianFoam` tutorial.
+---
+
+## Setup
+
+The setup is exactly the same as described in our [flow-over-heated-plate tutorial](tutorials-flow-over-heated-plate.html).
+
+## Available solvers
+
+Fluid participant:
+
+* OpenFOAM (buoyantPimpleFoam). For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+Solid participant:
+
+* OpenFOAM (laplacianFoam). For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+The solvers are currently only OpenFOAM related. For information regarding the nearest-projection mapping, have a look in the [OpenFOAM configuration section](adapter-openfoam-config.html).
+
+
+## Running the Simulation
+
+Open two separate terminals and start each participant by calling the respective run script.
+
+```
+cd fluid-openfoam
+./run.sh
+```
+and
+```
+cd solid-openfoam
+./run.sh
+```
+
+You can also run OpenFOAM in parallel by `./run.sh -parallel`. If you are using OpenFOAM v1712 / 5.x or older have a look in the `fluid-openfoam/system/controlDict` file and set the appropriate solver name.
+
+## Changes in the Simulation Setup
+
+As we are defining two meshes for each participant, we need to define them in the `precice-config.xml` and `preciceDict` configuration files. Additionally, we need to enable the `connectivity` switch for the adapter.
+
+### Changes in `precice-config.xml`
+In order to map from face nodes to face centers, both meshes need to be specified. The nodes-based mesh uses the write data and the centers-based mesh uses the read data. Have a look in the given `precice-config.xml` in this tutorial. Example: `Temperature` is calculated by the `Fluid` participant and passed to the `Solid` participant. Therefore, it is the write data of the participant `Fluid` and the read data of the participant `Solid`. This results in the following two meshes for this data:
+```
+
+
+
+
+
+
+```
+All further changes follow from this interface splitting. Have a look in the given config files for all details.
+
+### Notes on 2D Cases
+
+From the preCICE point of view, the simulation here is in 3D, as opposed to the original 2D case, as is often the case with 3D solvers (such as OpenFOAM). In such cases, we recommend keeping the out-of-plane thickness of the domain small and comparable to the in-plane cell size. Otherwise, the face centers will have a large distance to the face nodes, which might trigger a preCICE warning and preCICE may even filter out one of the meshes, especially in parallel simulations.
+
+
+## Post-processing
+
+Have a look at the [flow-over heated-plate](tutorials-flow-over-heated-plate.html) tutorial for the general aspects of post-processing.
+Since we now defined mesh connectivity on our interface, we can export the coupling interface with the tag `` in our `precice-config.xml`.
+Visualizing these files (e.g. using ParaView) will show a triangular mesh, even though you use hexahedral meshes. This has nothing to do with your mesh and is just caused by the way the connectivity is defined in preCICE. As described above, the function `setMeshTriangles` is used to define the connectivity. Hence, every interface cell/face is represented by two triangles. The following image should give you an impression of a possible triangulated coupling mesh, which consists purely of hexahedral cells:
+
+
+
+Connectivity is defined on meshes associated with mesh nodes, which are named respectively e.g. `Fluid-Mesh-Nodes`. In this case, you could directly see the interface without applying filters by loading the `.vtk` files. In order to visualize additionally center based meshes, where no connectivity is provided, select a Glyph filter in ParaView. Furthermore, it makes a difference, on which participant the `
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/p b/flow-over-heated-plate-nearest-projection/solid-openfoam/0/T
similarity index 62%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/p
rename to flow-over-heated-plate-nearest-projection/solid-openfoam/0/T
index a558fafcf..96fc74129 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/p
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/0/T
@@ -3,43 +3,35 @@ FoamFile
version 2.0;
format ascii;
class volScalarField;
- object p;
+ object T;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-dimensions [0 2 -2 0 0 0 0];
+dimensions [0 0 0 1 0 0 0];
-internalField uniform 0;
+internalField uniform 310;
boundaryField
{
- inlet
- {
- type zeroGradient;
- }
-
- outlet
+ interface
{
type fixedValue;
- value uniform 0;
+ value $internalField;
}
-
- flap
+ left
{
type zeroGradient;
}
-
- upperWall
+ right
{
type zeroGradient;
}
-
- lowerWall
+ bottom
{
- type zeroGradient;
+ type fixedValue;
+ value $internalField;
}
-
- frontAndBack
+ defaultFaces
{
type empty;
}
diff --git a/flow-over-heated-plate-nearest-projection/solid-openfoam/clean.sh b/flow-over-heated-plate-nearest-projection/solid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/transportProperties b/flow-over-heated-plate-nearest-projection/solid-openfoam/constant/transportProperties
similarity index 81%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/transportProperties
rename to flow-over-heated-plate-nearest-projection/solid-openfoam/constant/transportProperties
index bc81706ca..2a7a60f85 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/transportProperties
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/constant/transportProperties
@@ -8,8 +8,7 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-transportModel Newtonian;
+DT DT [ 0 2 -1 0 0 0 0 ] 1;
-nu nu [ 0 2 -1 0 0 0 0 ] 1e-03;
// ************************************************************************* //
diff --git a/flow-over-heated-plate-nearest-projection/solid-openfoam/run.sh b/flow-over-heated-plate-nearest-projection/solid-openfoam/run.sh
new file mode 100755
index 000000000..57e9395ee
--- /dev/null
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch solid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/flow-over-heated-plate-nearest-projection/solid-openfoam/system/blockMeshDict b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/blockMeshDict
new file mode 100644
index 000000000..d0fb694e6
--- /dev/null
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/blockMeshDict
@@ -0,0 +1,81 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ object blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+convertToMeters 1;
+
+vertices
+(
+
+ (0 -.25 0)
+ (1 -.25 0)
+ (1 0 0)
+ (0 0 0)
+
+ (0 -.25 .01)
+ (1 -.25 .01)
+ (1 0 .01)
+ (0 0 .01)
+
+);
+
+blocks
+(
+ hex (0 1 2 3 4 5 6 7) (32 16 1) simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+
+ left
+ {
+ type wall;
+ faces
+ (
+ (4 7 3 0)
+ );
+ }
+
+ right
+ {
+ type wall;
+ faces
+ (
+ (1 2 6 5)
+ );
+ }
+
+ interface
+ {
+ type wall;
+ faces
+ (
+ (7 6 2 3)
+ );
+ }
+
+ bottom
+ {
+ type wall;
+ faces
+ (
+ (4 0 1 5)
+ );
+ }
+
+);
+
+mergePatchPairs
+(
+);
+
+// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/controlDict b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/controlDict
similarity index 62%
rename from FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/controlDict
rename to flow-over-heated-plate-nearest-projection/solid-openfoam/system/controlDict
index 19433cd34..0920237a7 100644
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/controlDict
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/controlDict
@@ -8,10 +8,7 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-// Note: With OpenFOAM v1806 and OpenFOAM 6, the DyM solvers
-// were marked deprecated and merged into their respective standard solvers.
-application pimpleFoam; // OpenFOAM v1806, OpenFOAM 6, or newer
-// application pimpleDyMFoam; // OpenFOAM v1712, OpenFOAM 5.x, or older
+application laplacianFoam;
startFrom startTime;
@@ -19,13 +16,13 @@ startTime 0;
stopAt endTime;
-endTime 10;
+endTime 1;
deltaT 0.01;
-writeControl adjustableRunTime;
+writeControl runTime;
-writeInterval 0.1;
+writeInterval 0.2;
purgeWrite 0;
@@ -39,6 +36,8 @@ timeFormat general;
timePrecision 6;
+runTimeModifiable false;
+
functions
{
preCICE_Adapter
@@ -47,3 +46,7 @@ functions
libs ("libpreciceAdapterFunctionObject.so");
}
}
+
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate-nearest-projection/solid-openfoam/system/decomposeParDict b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/decomposeParDict
new file mode 100644
index 000000000..ad99cf6c5
--- /dev/null
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/decomposeParDict
@@ -0,0 +1,16 @@
+FoamFile {
+ version 2.0;
+ class dictionary;
+ object decomposeParDict;
+ format ascii;
+}
+
+numberOfSubdomains 2;
+
+method simple;
+
+simpleCoeffs
+{
+ n (2 1 1);
+ delta 0.001;
+}
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/fvSchemes b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/fvSchemes
similarity index 80%
rename from FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/fvSchemes
rename to flow-over-heated-plate-nearest-projection/solid-openfoam/system/fvSchemes
index 812dea539..6c9fc335b 100644
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/fvSchemes
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/fvSchemes
@@ -16,18 +16,18 @@ ddtSchemes
gradSchemes
{
default Gauss linear;
+ grad(T) Gauss linear;
}
divSchemes
{
default none;
- div(phi,U) bounded Gauss upwind;
- div((nuEff*dev2(T(grad(U))))) Gauss linear;
}
laplacianSchemes
{
- default Gauss linear corrected;
+ default none;
+ laplacian(DT,T) Gauss linear corrected;
}
interpolationSchemes
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/constant/transportProperties b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/fvSolution
similarity index 50%
rename from FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/constant/transportProperties
rename to flow-over-heated-plate-nearest-projection/solid-openfoam/system/fvSolution
index bc81706ca..74d1bdfd5 100644
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/constant/transportProperties
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/fvSolution
@@ -3,13 +3,26 @@ FoamFile
version 2.0;
format ascii;
class dictionary;
- location "constant";
- object transportProperties;
+ location "system";
+ object fvSolution;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-transportModel Newtonian;
+solvers
+{
+ T
+ {
+ solver PCG;
+ preconditioner DIC;
+ tolerance 1e-06;
+ relTol 0;
+ }
+}
+
+SIMPLE
+{
+ nNonOrthogonalCorrectors 2;
+}
-nu nu [ 0 2 -1 0 0 0 0 ] 1e-03;
// ************************************************************************* //
diff --git a/flow-over-heated-plate-nearest-projection/solid-openfoam/system/preciceDict b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/preciceDict
new file mode 100644
index 000000000..3d3e6ebaa
--- /dev/null
+++ b/flow-over-heated-plate-nearest-projection/solid-openfoam/system/preciceDict
@@ -0,0 +1,57 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object preciceDict;
+}
+
+preciceConfig "../precice-config.xml";
+
+participant Solid;
+
+modules (CHT);
+
+interfaces
+{
+ Interface1
+ {
+ mesh Solid-Mesh-Centers;
+ locations faceCenters;
+ connectivity false;
+ patches (interface);
+
+ readData
+ (
+ Temperature
+ );
+
+ writeData
+ (
+ );
+ };
+
+ Interfaces2
+ {
+ mesh Solid-Mesh-Nodes;
+ locations faceNodes;
+ connectivity true;
+ patches (interface);
+
+ readData
+ (
+ );
+
+ writeData
+ (
+ Heat-Flux
+ );
+ };
+};
+
+CHT
+{
+ k [ 1 1 -3 -1 0 0 0 ] 100;
+ solverType "basic";
+};
diff --git a/flow-over-heated-plate-steady-state/README.md b/flow-over-heated-plate-steady-state/README.md
new file mode 100644
index 000000000..66d7c5e64
--- /dev/null
+++ b/flow-over-heated-plate-steady-state/README.md
@@ -0,0 +1,42 @@
+---
+title: Flow over heated plate steady state
+permalink: tutorials-flow-over-heated-plate-steady-state.html
+keywords: CHT, steady-state, Code_Aster, OpenFOAM
+summary: Using a steady-state OpenFOAM solver for a CHT coupling with Code_Aster.
+---
+
+## Setup
+
+The setup for this tutorial is similar to the [flow over a heated plate](tutorials-flow-over-heated-plate.html) using OpenFOAM. In this tutorial OpenFOAM is used as the solver for the fluid domain, and code_aster is the solver for the solid domain. A difference here is that we are using a steady-state OpenFOAM solver for demonstration purposes, therefore the results between the two tutorials are not comparable.
+
+{% include note.html content="This is a pseudo-2D case, but we still set a 3D `solver-interface` in `precice-config.xml`, because the code_aster case is set up like this at the moment. Contributions here are particularly welcome!" %}
+
+## Available solvers
+
+Fluid participant:
+
+* OpenFOAM. We use buoyantSimpleFoam instead of the transient buoyantPimpleFoam. For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+Solid participant:
+
+* code_aster. The [code_aster adapter documentation](adapter-code_aster.html) is oriented on this tutorial case. In particular the described configuration settings.
+
+## Running the Simulation
+
+Open two separate terminals and start each participant by calling the respective `run.sh` script.
+
+## Post-processing
+
+Firstly, enable the ParaViS view in Salome-Meca by selecting the icon in the top of the screen.
+
+For visualizing the results of the fluid solver, go to `File -> Open ParaView File` and select the `fluid-openfoam.foam` file. If you're asked to choose a reader, please select `OpenFOAMReader` and click `Apply` to visualize the result.
+
+For visualizing the result of the solid solver, press again `Open ParaView File` and select the `output-..rmed` group. Again, click `Apply` to visualize the result. After setting the temperature scale for both domains to 300-310 K, the following result is given for timestep 200:
+
+
+
+The `.rmed` file output from Code_Aster can be viewed using [GMSH](https://gmsh.info/). The result is as follows:
+
+
+
+{% include disclaimer.html content="This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks." %}
diff --git a/flow-over-heated-plate-steady-state/clean-tutorial.sh b/flow-over-heated-plate-steady-state/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/flow-over-heated-plate-steady-state/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/T b/flow-over-heated-plate-steady-state/fluid-openfoam/0/T
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/T
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/T
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/U b/flow-over-heated-plate-steady-state/fluid-openfoam/0/U
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/U
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/U
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/alphat b/flow-over-heated-plate-steady-state/fluid-openfoam/0/alphat
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/alphat
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/alphat
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/epsilon b/flow-over-heated-plate-steady-state/fluid-openfoam/0/epsilon
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/epsilon
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/epsilon
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/k b/flow-over-heated-plate-steady-state/fluid-openfoam/0/k
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/k
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/k
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/nut b/flow-over-heated-plate-steady-state/fluid-openfoam/0/nut
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/nut
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/nut
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/p b/flow-over-heated-plate-steady-state/fluid-openfoam/0/p
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/p
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/p
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/p_rgh b/flow-over-heated-plate-steady-state/fluid-openfoam/0/p_rgh
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/0/p_rgh
rename to flow-over-heated-plate-steady-state/fluid-openfoam/0/p_rgh
diff --git a/flow-over-heated-plate-steady-state/fluid-openfoam/clean.sh b/flow-over-heated-plate-steady-state/fluid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/flow-over-heated-plate-steady-state/fluid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/constant/g b/flow-over-heated-plate-steady-state/fluid-openfoam/constant/g
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/constant/g
rename to flow-over-heated-plate-steady-state/fluid-openfoam/constant/g
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/constant/thermophysicalProperties b/flow-over-heated-plate-steady-state/fluid-openfoam/constant/thermophysicalProperties
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/constant/thermophysicalProperties
rename to flow-over-heated-plate-steady-state/fluid-openfoam/constant/thermophysicalProperties
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/constant/turbulenceProperties b/flow-over-heated-plate-steady-state/fluid-openfoam/constant/turbulenceProperties
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/constant/turbulenceProperties
rename to flow-over-heated-plate-steady-state/fluid-openfoam/constant/turbulenceProperties
diff --git a/flow-over-heated-plate-steady-state/fluid-openfoam/run.sh b/flow-over-heated-plate-steady-state/fluid-openfoam/run.sh
new file mode 100755
index 000000000..c191b9e48
--- /dev/null
+++ b/flow-over-heated-plate-steady-state/fluid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/blockMeshDict b/flow-over-heated-plate-steady-state/fluid-openfoam/system/blockMeshDict
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/blockMeshDict
rename to flow-over-heated-plate-steady-state/fluid-openfoam/system/blockMeshDict
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/controlDict b/flow-over-heated-plate-steady-state/fluid-openfoam/system/controlDict
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/controlDict
rename to flow-over-heated-plate-steady-state/fluid-openfoam/system/controlDict
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/fvSchemes b/flow-over-heated-plate-steady-state/fluid-openfoam/system/fvSchemes
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/fvSchemes
rename to flow-over-heated-plate-steady-state/fluid-openfoam/system/fvSchemes
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/fvSolution b/flow-over-heated-plate-steady-state/fluid-openfoam/system/fvSolution
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/fvSolution
rename to flow-over-heated-plate-steady-state/fluid-openfoam/system/fvSolution
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/preciceDict b/flow-over-heated-plate-steady-state/fluid-openfoam/system/preciceDict
similarity index 92%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/preciceDict
rename to flow-over-heated-plate-steady-state/fluid-openfoam/system/preciceDict
index d8a4e3a60..932e42bdd 100644
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/system/preciceDict
+++ b/flow-over-heated-plate-steady-state/fluid-openfoam/system/preciceDict
@@ -7,7 +7,7 @@ FoamFile
object preciceDict;
}
-preciceConfig "precice-config.xml";
+preciceConfig "../precice-config.xml";
participant Fluid;
@@ -32,4 +32,4 @@ interfaces
Heat-Transfer-Coefficient-Fluid
);
};
-};
\ No newline at end of file
+};
diff --git a/flow-over-heated-plate-steady-state/images/tutorials-flow-over-heated-plate-steady-state-post-processing.png b/flow-over-heated-plate-steady-state/images/tutorials-flow-over-heated-plate-steady-state-post-processing.png
new file mode 100644
index 000000000..ea5e81470
Binary files /dev/null and b/flow-over-heated-plate-steady-state/images/tutorials-flow-over-heated-plate-steady-state-post-processing.png differ
diff --git a/flow-over-heated-plate-steady-state/images/tutorials-flow-over-heated-plate-steady-state-result.png b/flow-over-heated-plate-steady-state/images/tutorials-flow-over-heated-plate-steady-state-result.png
new file mode 100644
index 000000000..d13a23b52
Binary files /dev/null and b/flow-over-heated-plate-steady-state/images/tutorials-flow-over-heated-plate-steady-state-result.png differ
diff --git a/flow-over-heated-plate-steady-state/precice-config.xml b/flow-over-heated-plate-steady-state/precice-config.xml
new file mode 100644
index 000000000..28d57303f
--- /dev/null
+++ b/flow-over-heated-plate-steady-state/precice-config.xml
@@ -0,0 +1,93 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/Fluid.foam b/flow-over-heated-plate-steady-state/solid-codeaster/REPE_OUT/.keepme
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Fluid/Fluid.foam
rename to flow-over-heated-plate-steady-state/solid-codeaster/REPE_OUT/.keepme
diff --git a/flow-over-heated-plate-steady-state/solid-codeaster/clean.sh b/flow-over-heated-plate-steady-state/solid-codeaster/clean.sh
new file mode 100755
index 000000000..c5eddaea2
--- /dev/null
+++ b/flow-over-heated-plate-steady-state/solid-codeaster/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_codeaster .
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/config.comm b/flow-over-heated-plate-steady-state/solid-codeaster/config.comm
similarity index 92%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/config.comm
rename to flow-over-heated-plate-steady-state/solid-codeaster/config.comm
index edfb02397..1325aa753 100644
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/config.comm
+++ b/flow-over-heated-plate-steady-state/solid-codeaster/config.comm
@@ -1,7 +1,7 @@
settings = \
{'base-path': tutorial_root,
'couplings': [['Solid-Interface', 'Fluid-Interface']],
- 'participants': {'Solid': {'directory': 'Solid',
+ 'participants': {'Solid': {'directory': '.',
'domain-decomposed': False,
'interfaces': [{'material-id': 0,
'name': 'Solid-Interface',
@@ -14,7 +14,7 @@ settings = \
'write-mesh': 'Solid-Interface-Nodes'}],
'non-linear': False,
'solver': 'Code_Aster'}},
- 'precice-config-file': 'precice-config.xml',
+ 'precice-config-file': '../precice-config.xml',
'simulation': {'force-explicit': False,
'force-parallel': False,
'max-coupling-iterations': 100,
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/def.comm b/flow-over-heated-plate-steady-state/solid-codeaster/def.comm
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/def.comm
rename to flow-over-heated-plate-steady-state/solid-codeaster/def.comm
diff --git a/flow-over-heated-plate-steady-state/solid-codeaster/run.sh b/flow-over-heated-plate-steady-state/solid-codeaster/run.sh
new file mode 100755
index 000000000..1dbe48f7f
--- /dev/null
+++ b/flow-over-heated-plate-steady-state/solid-codeaster/run.sh
@@ -0,0 +1,11 @@
+#!/bin/sh
+set -e -u
+
+echo "Warning: this case requires a manual preparation step for code_aster."
+echo "You also need to set an absolute path as exchange-directory in precice-config.xml."
+echo "See the tutorial and code_aster adapter documentation pages for more:"
+echo "https://www.precice.org/adapter-code_aster.html\n"
+
+export TUTORIAL_ROOT=${PWD}
+export PRECICE_PARTICIPANT=Solid
+as_run --run solid.export
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/solid.astk b/flow-over-heated-plate-steady-state/solid-codeaster/solid.astk
similarity index 83%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/solid.astk
rename to flow-over-heated-plate-steady-state/solid-codeaster/solid.astk
index 4b5fdb5c9..91899b20e 100644
--- a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/solid.astk
+++ b/flow-over-heated-plate-steady-state/solid-codeaster/solid.astk
@@ -18,7 +18,7 @@ etude,fich,4,serv Local
serv_fich_export -1
surcharge,nbfic 0
etude,fich,6,FR F
-path_etude /path/to/tutorials/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid
+path_etude /path/to/tutorials/flow-over-heated-plate-steady-state/solid-codeaster
option,rep_outils 0
etude,fich,3,resultat 0
etude,fich,6,UL 8
@@ -43,7 +43,7 @@ rex non
etude,fich,1,nom ./solid.mmed
etude,fich,1,type mmed
suivi_interactif 0
-path_sources /path/to/tutorials/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid
+path_sources /path/to/tutorials/flow-over-heated-plate-steady-state/solid-codeaster
pre_eda non
etude,fich,4,FR F
option,multiple 1
@@ -58,9 +58,9 @@ make_etude run
option,depart 1
option,only_nook 1
opt_val,ORBInitRef _VIDE
-nom_profil /path/to/tutorials/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/solid.astk
+nom_profil /path/to/tutorials/flow-over-heated-plate-steady-state/solid-codeaster/solid.astk
args _VIDE
-etude,fich,7,nom /path/to/tutorials/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/REPE_OUT
+etude,fich,7,nom /path/to/tutorials/flow-over-heated-plate-steady-state/solid-codeaster/REPE_OUT
etude,fich,0,donnee 1
etude,fich,5,resultat 1
etude,fich,7,compress 0
@@ -86,7 +86,7 @@ etude,fich,6,resultat 1
opt_val,rep_outils _VIDE
M_3 non
etude,fich,2,UL 90
-path_surcharge /path/to/tutorials/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid
+path_surcharge /path/to/tutorials/flow-over-heated-plate-steady-state/solid-codeaster
consult non
M_4 non
asno non
@@ -126,7 +126,7 @@ etude,fich,0,nom /path/to/code_aster-adapter/cht/adapter.comm
etude,fich,2,serv Local
option,exectool 1
asverif non
-etude,fich,2,nom ./../config.comm
+etude,fich,2,nom ./config.comm
option,after_job 1
opt_val,depart _VIDE
opt_val,mpi_nbnoeud 1
@@ -145,4 +145,4 @@ etude,nbfic 8
agla non
opt_val,nbmaxnook 5
version stable
-path_tests /path/to/tutorials/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid
+path_tests /path/to/tutorials/flow-over-heated-plate-steady-state/solid-codeaster
diff --git a/CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/solid.mmed b/flow-over-heated-plate-steady-state/solid-codeaster/solid.mmed
similarity index 100%
rename from CHT/flow-over-plate/buoyantSimpleFoam-aster/Solid/solid.mmed
rename to flow-over-heated-plate-steady-state/solid-codeaster/solid.mmed
diff --git a/flow-over-heated-plate/README.md b/flow-over-heated-plate/README.md
new file mode 100644
index 000000000..01a6f0ff2
--- /dev/null
+++ b/flow-over-heated-plate/README.md
@@ -0,0 +1,83 @@
+---
+title: Flow over heated plate
+permalink: tutorials-flow-over-heated-plate.html
+keywords: tutorial, CHT, conjugate-heat transfer, OpenFOAM, FEniCS, Nutils
+summary: This tutorial describes how to run a conjugate heat transfer coupled simulation using preCICE and any fluid-solid solver combination of our [officially provided adapter codes](adapters-overview.html).
+---
+
+## Setup
+
+This scenario consists of one fluid and one solid participant and it is inspired by Vynnycky et al. [1]. A fluid enters a channel with temperature $$ T_\infty $$, where it comes in contact with a solid plate. The plate is heated at its bottom and has a constant temperature of $$ T_{hot} $$.
+
+
+
+The test case is two-dimensional and a serial-implicit coupling with Aitken underrelaxation is used for the coupling.
+
+The inlet velocity is $$ u_{\infty} = 0.1 m/s $$, the inlet temperature is $$ T_{\infty} = 300K $$. The fluid and solid have the same thermal conductivities $$ k_S = k_F = 100 W/m/K $$. Further material properties of the fluid are its viscosity $$ mu = 0.0002 kg/m/s $$ and specific heat capacity $$ c_p = 5000 J/kg/K $$. The Prandtl number $$ Pr = 0.01 $$ follows from thermal conductivity, viscosity and specific heat capacity. The solid has the thermal diffusivity $$ \alpha = 1 m^2/s $$. The gravitational acceleration is $$ g = 9.81 m/s^2 $$.
+
+## Available solvers
+
+By default, the fluid participant reads heat-flux values and the solid participant reads temperature values for the coupled simulation. The following participants are available:
+
+Fluid participant:
+
+* OpenFOAM (buoyantPimpleFoam). For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+Solid participant:
+
+* OpenFOAM (laplacianFoam). For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+* FEniCS. For more information, have a look at the [FeniCS adapter documentation](adapter-fenics.html).
+
+## Running the Simulation
+
+All listed solvers can be used in order to run the simulation. Open two separate terminals and start the desired fluid and solid participant by calling the respective run script `run.sh` located in the participant directory. For example:
+
+```
+cd fluid-openfoam
+./run.sh
+```
+and
+```
+cd solid-fenics
+./run.sh
+```
+in order to use OpenFOAM and FEniCS for this test case. Feel free to try different combinations, they should all run and give approximately similar results.
+
+## Post-processing
+
+How to visualize the simulation results depends on the selected solvers. Most of the solvers generate VTK files which can visualized using ParaView or similar tools.
+In case of OpenFOAM, you can open the `.foam` file with ParaView, or create VTK files with `foamToVTK`.
+
+An example of the visualized expected results looks as follows:
+
+
+
+Observe that the temperature at the bottom of the plate is 310K and at the inlet 300K. On the interface, the temperature is between these values. An area of higher temperature is formed above the plate, which is shifted towards the front, driven by the flow.
+
+You may use additional filters, such as the Calculator and the Plot Over Line, to obtain the distribution of the non-dimensional temperature $$ (T-T_{inlet})/(T_{solid}-T_{inlet}) $$:
+
+
+
+### Compare results
+
+First generate the output for each run by adding export to the participant `Solid` in `precice-config.xml`:
+
+```
+
+
+
+
+ ...
+
+```
+
+After that running a case from this tutorial will export data into `solid-*/preCICE-output`. To visualize and compare these results run `python3 plot-final-interface-temperature.py` (You can install the required python packages by running `pip3 install -r plot-final-interface-temperature-requirements.txt`). This will plot the dimensionless temperature `theta = (T-300)/(310-300)` (with `T` being the temperature) across the coupling interface, i.e. where the solid and the fluid meet and exchange heat. The x-axis shows the x coordinate and the y-axis the dimensionless temperature `theta` at the interface. If you want to exclude certain cases, simply comment out the corresponding lines in the script. For reference see below:
+
+
+
+## References
+
+[1] M. Vynnycky, S. Kimura, K. Kanev, and I. Pop. Forced convection heat transfer from a flat plate: the conjugate problem. International Journal of Heat and Mass Transfer, 41(1):45 – 59, 1998.
+
+{% include disclaimer.html content="This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks." %}
diff --git a/flow-over-heated-plate/clean-tutorial.sh b/flow-over-heated-plate/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/flow-over-heated-plate/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/T b/flow-over-heated-plate/fluid-openfoam/0/T
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/T
rename to flow-over-heated-plate/fluid-openfoam/0/T
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/U b/flow-over-heated-plate/fluid-openfoam/0/U
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/U
rename to flow-over-heated-plate/fluid-openfoam/0/U
diff --git a/flow-over-heated-plate/fluid-openfoam/0/alphat b/flow-over-heated-plate/fluid-openfoam/0/alphat
new file mode 100644
index 000000000..8cdbda4b4
--- /dev/null
+++ b/flow-over-heated-plate/fluid-openfoam/0/alphat
@@ -0,0 +1,61 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ location "0";
+ object alphat;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions [ 1 -1 -1 0 0 0 0 ];
+
+internalField uniform 0;
+
+boundaryField
+{
+ interface
+ {
+ type compressible::alphatWallFunction;
+ value uniform 0;
+ }
+ inlet
+ {
+ type compressible::alphatWallFunction;
+ value uniform 0;
+ }
+ outlet
+ {
+ type compressible::alphatWallFunction;
+ value uniform 0;
+ }
+ top
+ {
+ type compressible::alphatWallFunction;
+ value uniform 0;
+ }
+ bottom
+ {
+ type compressible::alphatWallFunction;
+ value uniform 0;
+ }
+ slip-bottom
+ {
+ type compressible::alphatWallFunction;
+ value uniform 0;
+ }
+ defaultFaces
+ {
+ type empty;
+ }
+}
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/fluid-openfoam/0/epsilon b/flow-over-heated-plate/fluid-openfoam/0/epsilon
new file mode 100644
index 000000000..a1374d174
--- /dev/null
+++ b/flow-over-heated-plate/fluid-openfoam/0/epsilon
@@ -0,0 +1,61 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ location "0";
+ object epsilon;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions [ 0 2 -3 0 0 0 0 ];
+
+internalField uniform 0.01;
+
+boundaryField
+{
+ interface
+ {
+ type epsilonWallFunction;
+ value uniform 0.01;
+ }
+ inlet
+ {
+ type epsilonWallFunction;
+ value uniform 0.01;
+ }
+ outlet
+ {
+ type epsilonWallFunction;
+ value uniform 0.01;
+ }
+ top
+ {
+ type epsilonWallFunction;
+ value uniform 0.01;
+ }
+ bottom
+ {
+ type epsilonWallFunction;
+ value uniform 0.01;
+ }
+ slip-bottom
+ {
+ type epsilonWallFunction;
+ value uniform 0.01;
+ }
+ defaultFaces
+ {
+ type empty;
+ }
+}
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/fluid-openfoam/0/k b/flow-over-heated-plate/fluid-openfoam/0/k
new file mode 100644
index 000000000..87a6a0a83
--- /dev/null
+++ b/flow-over-heated-plate/fluid-openfoam/0/k
@@ -0,0 +1,61 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ location "0";
+ object k;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions [ 0 2 -2 0 0 0 0 ];
+
+internalField uniform 0.1;
+
+boundaryField
+{
+ interface
+ {
+ type kqRWallFunction;
+ value uniform 0.1;
+ }
+ inlet
+ {
+ type kqRWallFunction;
+ value uniform 0.1;
+ }
+ outlet
+ {
+ type kqRWallFunction;
+ value uniform 0.1;
+ }
+ top
+ {
+ type kqRWallFunction;
+ value uniform 0.1;
+ }
+ slip-bottom
+ {
+ type kqRWallFunction;
+ value uniform 0.1;
+ }
+ bottom
+ {
+ type kqRWallFunction;
+ value uniform 0.1;
+ }
+ defaultFaces
+ {
+ type empty;
+ }
+}
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/fluid-openfoam/0/nut b/flow-over-heated-plate/fluid-openfoam/0/nut
new file mode 100644
index 000000000..9cb00d410
--- /dev/null
+++ b/flow-over-heated-plate/fluid-openfoam/0/nut
@@ -0,0 +1,61 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ location "0";
+ object nut;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions [ 0 2 -1 0 0 0 0 ];
+
+internalField uniform 0;
+
+boundaryField
+{
+ interface
+ {
+ type nutkWallFunction;
+ value uniform 0;
+ }
+ inlet
+ {
+ type nutkWallFunction;
+ value uniform 0;
+ }
+ outlet
+ {
+ type nutkWallFunction;
+ value uniform 0;
+ }
+ top
+ {
+ type nutkWallFunction;
+ value uniform 0;
+ }
+ bottom
+ {
+ type nutkWallFunction;
+ value uniform 0;
+ }
+ slip-bottom
+ {
+ type nutkWallFunction;
+ value uniform 0;
+ }
+ defaultFaces
+ {
+ type empty;
+ }
+}
+
+
+// ************************************************************************* //
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/p b/flow-over-heated-plate/fluid-openfoam/0/p
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/p
rename to flow-over-heated-plate/fluid-openfoam/0/p
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/p_rgh b/flow-over-heated-plate/fluid-openfoam/0/p_rgh
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/0/p_rgh
rename to flow-over-heated-plate/fluid-openfoam/0/p_rgh
diff --git a/flow-over-heated-plate/fluid-openfoam/clean.sh b/flow-over-heated-plate/fluid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/flow-over-heated-plate/fluid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/constant/g b/flow-over-heated-plate/fluid-openfoam/constant/g
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/constant/g
rename to flow-over-heated-plate/fluid-openfoam/constant/g
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/constant/thermophysicalProperties b/flow-over-heated-plate/fluid-openfoam/constant/thermophysicalProperties
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/constant/thermophysicalProperties
rename to flow-over-heated-plate/fluid-openfoam/constant/thermophysicalProperties
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/constant/turbulenceProperties b/flow-over-heated-plate/fluid-openfoam/constant/turbulenceProperties
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/constant/turbulenceProperties
rename to flow-over-heated-plate/fluid-openfoam/constant/turbulenceProperties
diff --git a/flow-over-heated-plate/fluid-openfoam/run.sh b/flow-over-heated-plate/fluid-openfoam/run.sh
new file mode 100755
index 000000000..c191b9e48
--- /dev/null
+++ b/flow-over-heated-plate/fluid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/blockMeshDict b/flow-over-heated-plate/fluid-openfoam/system/blockMeshDict
similarity index 93%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/blockMeshDict
rename to flow-over-heated-plate/fluid-openfoam/system/blockMeshDict
index 0454541cf..55281d6a5 100644
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/blockMeshDict
+++ b/flow-over-heated-plate/fluid-openfoam/system/blockMeshDict
@@ -14,7 +14,6 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-convertToMeters 1;
vertices
(
@@ -23,22 +22,22 @@ vertices
(1 .5 0)
(0 .5 0)
- (0 0 .05)
- (1 0 .05)
- (1 .5 .05)
- (0 .5 .05)
+ (0 0 .4)
+ (1 0 .4)
+ (1 .5 .4)
+ (0 .5 .4)
(3 0 0)
(3 .5 0)
- (3 0 .05)
- (3 .5 .05)
+ (3 0 .4)
+ (3 .5 .4)
(-.5 0 0)
(-.5 .5 0)
- (-.5 .5 .05)
- (-.5 0 .05)
+ (-.5 .5 .4)
+ (-.5 0 .4)
);
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/controlDict b/flow-over-heated-plate/fluid-openfoam/system/controlDict
similarity index 98%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/controlDict
rename to flow-over-heated-plate/fluid-openfoam/system/controlDict
index d036b8c52..bdfdb5da9 100644
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/controlDict
+++ b/flow-over-heated-plate/fluid-openfoam/system/controlDict
@@ -29,7 +29,7 @@ deltaT 0.01;
writeControl runTime;
-writeInterval .2;
+writeInterval 0.2;
purgeWrite 0;
diff --git a/flow-over-heated-plate/fluid-openfoam/system/decomposeParDict b/flow-over-heated-plate/fluid-openfoam/system/decomposeParDict
new file mode 100644
index 000000000..ad99cf6c5
--- /dev/null
+++ b/flow-over-heated-plate/fluid-openfoam/system/decomposeParDict
@@ -0,0 +1,16 @@
+FoamFile {
+ version 2.0;
+ class dictionary;
+ object decomposeParDict;
+ format ascii;
+}
+
+numberOfSubdomains 2;
+
+method simple;
+
+simpleCoeffs
+{
+ n (2 1 1);
+ delta 0.001;
+}
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/fvSchemes b/flow-over-heated-plate/fluid-openfoam/system/fvSchemes
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/fvSchemes
rename to flow-over-heated-plate/fluid-openfoam/system/fvSchemes
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/fvSolution b/flow-over-heated-plate/fluid-openfoam/system/fvSolution
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/fvSolution
rename to flow-over-heated-plate/fluid-openfoam/system/fvSolution
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/preciceDict b/flow-over-heated-plate/fluid-openfoam/system/preciceDict
similarity index 85%
rename from CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/preciceDict
rename to flow-over-heated-plate/fluid-openfoam/system/preciceDict
index 3bd0bf9ec..be3dc807c 100644
--- a/CHT/flow-over-plate/buoyantPimpleFoam-nutils/OpenFOAM/system/preciceDict
+++ b/flow-over-heated-plate/fluid-openfoam/system/preciceDict
@@ -9,7 +9,7 @@ FoamFile
preciceConfig "../precice-config.xml";
-participant OpenFOAM;
+participant Fluid;
modules (CHT);
@@ -17,7 +17,7 @@ interfaces
{
Interface1
{
- mesh OpenFOAM-Mesh;
+ mesh Fluid-Mesh;
patches (interface);
readData
@@ -30,4 +30,4 @@ interfaces
Temperature
);
};
-};
\ No newline at end of file
+};
diff --git a/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-example.png b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-example.png
new file mode 100644
index 000000000..a99b9c43b
Binary files /dev/null and b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-example.png differ
diff --git a/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-graph-result.png b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-graph-result.png
new file mode 100644
index 000000000..f8b568265
Binary files /dev/null and b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-graph-result.png differ
diff --git a/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-result-openfoam.png b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-result-openfoam.png
new file mode 100644
index 000000000..61d648f96
Binary files /dev/null and b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-result-openfoam.png differ
diff --git a/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-results-comparison.png b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-results-comparison.png
new file mode 100644
index 000000000..c714ed2d2
Binary files /dev/null and b/flow-over-heated-plate/images/tutorials-flow-over-heated-plate-results-comparison.png differ
diff --git a/flow-over-heated-plate/plot-final-interface-temperature-requirements.txt b/flow-over-heated-plate/plot-final-interface-temperature-requirements.txt
new file mode 100644
index 000000000..47cfc5967
--- /dev/null
+++ b/flow-over-heated-plate/plot-final-interface-temperature-requirements.txt
@@ -0,0 +1,3 @@
+vtk
+numpy
+matplotlib
diff --git a/flow-over-heated-plate/plot-final-interface-temperature.py b/flow-over-heated-plate/plot-final-interface-temperature.py
new file mode 100644
index 000000000..ffe5e424e
--- /dev/null
+++ b/flow-over-heated-plate/plot-final-interface-temperature.py
@@ -0,0 +1,63 @@
+import vtk
+from matplotlib import pyplot as plt
+import numpy as np
+
+
+def vtk_to_dict(case):
+ vtkFileName = "solid-{}/preCICE-output/Fluid-Mesh-Solid.final.vtk".format(case)
+ # read the vtk file as an unstructured grid
+ reader = vtk.vtkUnstructuredGridReader()
+ reader.SetFileName(vtkFileName)
+ reader.ReadAllVectorsOn()
+ reader.ReadAllScalarsOn()
+ reader.Update()
+
+ # obtain the data
+ data = reader.GetOutput()
+ n_data = data.GetPointData().GetNumberOfTuples()
+
+ name = "Temperature"
+ data_names = []
+ i = 0
+ max_i = data.GetPointData().GetNumberOfArrays()
+ while i < max_i:
+ this_data_name = data.GetPointData().GetArray(i).GetName()
+ data_names.append(this_data_name)
+ if(this_data_name == name):
+ data_id = i
+ break
+ i += 1
+
+ data_dict = {}
+
+ if not data_id:
+ raise Exception(
+ "For file {} name {} not found. Only the following names are available: {}. "
+ "Aborting!".format(vtkFileName, name, data_names))
+ for i in range(n_data):
+ data_dict[data.GetPoint(i)] = data.GetPointData().GetArray(data_id).GetValue(i)
+
+ return data_dict
+
+
+cases = []
+cases.append('fenics')
+cases.append('openfoam')
+cases.append('nutils')
+
+case_labels = {'fenics': 'OpenFOAM-FEniCS', 'openfoam': 'OpenFOAM-OpenFOAM', 'nutils': 'OpenFOAM-Nutils', }
+styles = [':', '-', '--']
+colors = ['r', 'b', 'g', 'k']
+i = 0
+
+for case in cases:
+ case_data = vtk_to_dict(case)
+ x, t = [p[0] for p in case_data.keys()], np.array(list(case_data.values()))
+ theta = (t - 300) / (310 - 300)
+ plt.plot(x, theta, colors[i % 4] + styles[i % 3], label=case_labels[case])
+ i += 1
+
+plt.ylabel("Theta")
+plt.xlabel("x-coordinate along coupling interface")
+plt.legend()
+plt.show()
diff --git a/flow-over-heated-plate/precice-config.xml b/flow-over-heated-plate/precice-config.xml
new file mode 100644
index 000000000..9c1337449
--- /dev/null
+++ b/flow-over-heated-plate/precice-config.xml
@@ -0,0 +1,64 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/flow-over-heated-plate/solid-fenics/clean.sh b/flow-over-heated-plate/solid-fenics/clean.sh
new file mode 100755
index 000000000..3a8b4619d
--- /dev/null
+++ b/flow-over-heated-plate/solid-fenics/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_fenics .
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/Solid/precice-adapter-config.json b/flow-over-heated-plate/solid-fenics/precice-adapter-config.json
similarity index 100%
rename from CHT/flow-over-plate/buoyantPimpleFoam-fenics/Solid/precice-adapter-config.json
rename to flow-over-heated-plate/solid-fenics/precice-adapter-config.json
diff --git a/flow-over-heated-plate/solid-fenics/run.sh b/flow-over-heated-plate/solid-fenics/run.sh
new file mode 100755
index 000000000..15315c67d
--- /dev/null
+++ b/flow-over-heated-plate/solid-fenics/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+python3 solid.py
diff --git a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/Solid/heat.py b/flow-over-heated-plate/solid-fenics/solid.py
similarity index 98%
rename from CHT/flow-over-plate/buoyantPimpleFoam-fenics/Solid/heat.py
rename to flow-over-heated-plate/solid-fenics/solid.py
index b2cce5ff1..105ea30a9 100644
--- a/CHT/flow-over-plate/buoyantPimpleFoam-fenics/Solid/heat.py
+++ b/flow-over-heated-plate/solid-fenics/solid.py
@@ -191,7 +191,7 @@ def determine_heat_flux(V_g, u, k, flux):
if precice.is_time_window_complete():
tol = 10e-5 # we need some tolerance, since otherwise output might be skipped.
- if abs((t + tol) % dt_out) < 2*tol: # output if t is a multiple of dt_out
+ if abs((t + tol) % dt_out) < 2 * tol: # output if t is a multiple of dt_out
print("output vtk for time = {}".format(float(t)))
file_out << u_n
diff --git a/flow-over-heated-plate/solid-nutils/clean.sh b/flow-over-heated-plate/solid-nutils/clean.sh
new file mode 100755
index 000000000..6893c1ea5
--- /dev/null
+++ b/flow-over-heated-plate/solid-nutils/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_nutils .
diff --git a/flow-over-heated-plate/solid-nutils/run.sh b/flow-over-heated-plate/solid-nutils/run.sh
new file mode 100755
index 000000000..21bd5c3b1
--- /dev/null
+++ b/flow-over-heated-plate/solid-nutils/run.sh
@@ -0,0 +1,5 @@
+#!/bin/bash
+set -e -u
+
+python3 solid.py
+
diff --git a/flow-over-heated-plate/solid-nutils/solid.py b/flow-over-heated-plate/solid-nutils/solid.py
new file mode 100644
index 000000000..64672be40
--- /dev/null
+++ b/flow-over-heated-plate/solid-nutils/solid.py
@@ -0,0 +1,123 @@
+#! /usr/bin/env python3
+
+import nutils
+import treelog
+import numpy as np
+import precice
+from mpi4py import MPI
+
+
+def main():
+
+ print("Running utils")
+
+ # define the Nutils mesh
+ grid = [np.linspace(a, b, round((b - a) / size) + 1) for (a, b, size) in [(0, 1, 0.05), (-.25, 0, 0.05)]]
+ domain, geom = nutils.mesh.rectilinear(grid)
+
+ # Nutils namespace
+ ns = nutils.function.Namespace()
+ ns.x = geom
+
+ ns.basis = domain.basis('std', degree=1) # linear finite elements
+ ns.u = 'basis_n ?lhs_n' # solution
+ ns.dudt = 'basis_n (?lhs_n - ?lhs0_n) / ?dt' # time derivative
+ ns.flux = 'basis_n ?fluxdofs_n' # heat flux
+ ns.k = 100 # thermal diffusivity
+ ns.uwall = 310 # wall temperature
+
+ # define the weak form
+ res = domain.integral('(basis_n dudt + k basis_n,i u_,i) d:x' @ ns, degree=2)
+
+ # define Dirichlet boundary condition
+ sqr = domain.boundary['bottom'].integral('(u - uwall)^2 d:x' @ ns, degree=2)
+ cons = nutils.solver.optimize('lhs', sqr, droptol=1e-15)
+
+ # preCICE setup
+ interface = precice.Interface("Solid", "../precice-config.xml", 0, 1)
+
+ # define coupling mesh
+ mesh_name = "Solid-Mesh"
+ mesh_id = interface.get_mesh_id(mesh_name)
+ coupling_boundary = domain.boundary['top']
+ coupling_sample = coupling_boundary.sample('gauss', degree=2) # mesh vertices at Gauss points
+ vertices = coupling_sample.eval(ns.x)
+ vertex_ids = interface.set_mesh_vertices(mesh_id, vertices)
+
+ # coupling data
+ flux_id = interface.get_data_id("Heat-Flux", mesh_id)
+ temperature_id = interface.get_data_id("Temperature", mesh_id)
+
+ # helper functions to project heat flux to coupling boundary
+ projection_matrix = coupling_boundary.integrate(ns.eval_nm('basis_n basis_m d:x'), degree=2)
+ projection_cons = np.zeros(res.shape)
+ projection_cons[projection_matrix.rowsupp(1e-15)] = np.nan
+ def fluxdofs(v): return projection_matrix.solve(v, constrain=projection_cons)
+
+ precice_dt = interface.initialize()
+
+ cons0 = cons # to not lose the Dirichlet BC at the bottom
+ lhs0 = np.zeros(res.shape) # solution from previous timestep
+ timestep = 0
+ dt = 0.01
+
+ # set u = uwall as initial condition and visualize
+ sqr = domain.integral('(u - uwall)^2' @ ns, degree=2)
+ lhs0 = nutils.solver.optimize('lhs', sqr)
+ bezier = domain.sample('bezier', 2)
+ x, u = bezier.eval(['x_i', 'u'] @ ns, lhs=lhs0)
+ with treelog.add(treelog.DataLog()):
+ nutils.export.vtk('Solid_0', bezier.tri, x, T=u)
+
+ while interface.is_coupling_ongoing():
+
+ # read temperature from interface
+ if interface.is_read_data_available():
+ temperature_values = interface.read_block_scalar_data(temperature_id, vertex_ids)
+ temperature_function = coupling_sample.asfunction(temperature_values)
+
+ sqr = coupling_sample.integral((ns.u - temperature_function)**2)
+ cons = nutils.solver.optimize('lhs', sqr, droptol=1e-15, constrain=cons0)
+
+ # save checkpoint
+ if interface.is_action_required(precice.action_write_iteration_checkpoint()):
+ lhs_checkpoint = lhs0
+ timestep_checkpoint = timestep
+ interface.mark_action_fulfilled(precice.action_write_iteration_checkpoint())
+
+ # potentially adjust non-matching timestep sizes
+ dt = min(dt, precice_dt)
+
+ # solve nutils timestep
+ lhs = nutils.solver.solve_linear('lhs', res, constrain=cons, arguments=dict(lhs0=lhs0, dt=dt))
+
+ # write heat fluxes to interface
+ if interface.is_write_data_required(dt):
+ flux_function = res.eval(lhs0=lhs0, lhs=lhs, dt=dt)
+ flux_values = coupling_sample.eval('-flux' @ ns, fluxdofs=fluxdofs(flux_function))
+ interface.write_block_scalar_data(flux_id, vertex_ids, flux_values)
+
+ # do the coupling
+ precice_dt = interface.advance(dt)
+
+ # advance variables
+ timestep += 1
+ lhs0 = lhs
+
+ # read checkpoint if required
+ if interface.is_action_required(precice.action_read_iteration_checkpoint()):
+ lhs0 = lhs_checkpoint
+ timestep = timestep_checkpoint
+ interface.mark_action_fulfilled(precice.action_read_iteration_checkpoint())
+ else: # go to next timestep
+ if timestep % 20 == 0: # visualize
+ bezier = domain.sample('bezier', 2)
+ x, u = bezier.eval(['x_i', 'u'] @ ns, lhs=lhs)
+ with treelog.add(treelog.DataLog()):
+ nutils.export.vtk('Solid_' + str(timestep), bezier.tri, x, T=u)
+
+ interface.finalize()
+
+
+if __name__ == '__main__':
+ nutils.cli.run(main)
diff --git a/flow-over-heated-plate/solid-openfoam/0/T b/flow-over-heated-plate/solid-openfoam/0/T
new file mode 100644
index 000000000..ffaa360be
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/0/T
@@ -0,0 +1,47 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ object T;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions [0 0 0 1 0 0 0];
+
+internalField uniform 310;
+
+boundaryField
+{
+ interface
+ {
+ type fixedValue;
+ value $internalField;
+ }
+ left
+ {
+ type zeroGradient;
+ }
+ right
+ {
+ type zeroGradient;
+ }
+ bottom
+ {
+ type fixedValue;
+ value $internalField;
+ }
+ defaultFaces
+ {
+ type empty;
+ }
+}
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/solid-openfoam/clean.sh b/flow-over-heated-plate/solid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/flow-over-heated-plate/solid-openfoam/constant/transportProperties b/flow-over-heated-plate/solid-openfoam/constant/transportProperties
new file mode 100644
index 000000000..40eaee612
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/constant/transportProperties
@@ -0,0 +1,21 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object transportProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+DT DT [ 0 2 -1 0 0 0 0 ] 1;
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/solid-openfoam/run.sh b/flow-over-heated-plate/solid-openfoam/run.sh
new file mode 100755
index 000000000..57e9395ee
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch solid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/flow-over-heated-plate/solid-openfoam/system/blockMeshDict b/flow-over-heated-plate/solid-openfoam/system/blockMeshDict
new file mode 100644
index 000000000..39e86a6eb
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/system/blockMeshDict
@@ -0,0 +1,87 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 2.4.0 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ object blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+
+vertices
+(
+
+ (0 -.25 0)
+ (1 -.25 0)
+ (1 0 0)
+ (0 0 0)
+
+ (0 -.25 .4)
+ (1 -.25 .4)
+ (1 0 .4)
+ (0 0 .4)
+
+);
+
+blocks
+(
+ hex (0 1 2 3 4 5 6 7) (32 16 1) simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+
+ left
+ {
+ type wall;
+ faces
+ (
+ (4 7 3 0)
+ );
+ }
+
+ right
+ {
+ type wall;
+ faces
+ (
+ (1 2 6 5)
+ );
+ }
+
+ interface
+ {
+ type wall;
+ faces
+ (
+ (7 6 2 3)
+ );
+ }
+
+ bottom
+ {
+ type wall;
+ faces
+ (
+ (4 0 1 5)
+ );
+ }
+
+);
+
+mergePatchPairs
+(
+);
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/solid-openfoam/system/controlDict b/flow-over-heated-plate/solid-openfoam/system/controlDict
new file mode 100644
index 000000000..5570d8606
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/system/controlDict
@@ -0,0 +1,59 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object controlDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+application laplacianFoam;
+
+startFrom startTime;
+
+startTime 0;
+
+stopAt endTime;
+
+endTime 1;
+
+deltaT 0.01;
+
+writeControl runTime;
+
+writeInterval 0.2;
+
+purgeWrite 0;
+
+writeFormat ascii;
+
+writePrecision 6;
+
+writeCompression off;
+
+timeFormat general;
+
+timePrecision 6;
+
+runTimeModifiable false;
+
+functions
+{
+ preCICE_Adapter
+ {
+ type preciceAdapterFunctionObject;
+ libs ("libpreciceAdapterFunctionObject.so");
+ }
+}
+
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/solid-openfoam/system/decomposeParDict b/flow-over-heated-plate/solid-openfoam/system/decomposeParDict
new file mode 100644
index 000000000..ad99cf6c5
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/system/decomposeParDict
@@ -0,0 +1,16 @@
+FoamFile {
+ version 2.0;
+ class dictionary;
+ object decomposeParDict;
+ format ascii;
+}
+
+numberOfSubdomains 2;
+
+method simple;
+
+simpleCoeffs
+{
+ n (2 1 1);
+ delta 0.001;
+}
diff --git a/flow-over-heated-plate/solid-openfoam/system/fvSchemes b/flow-over-heated-plate/solid-openfoam/system/fvSchemes
new file mode 100644
index 000000000..b615f6dc7
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/system/fvSchemes
@@ -0,0 +1,51 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+ default Euler;
+}
+
+gradSchemes
+{
+ default Gauss linear;
+ grad(T) Gauss linear;
+}
+
+divSchemes
+{
+ default none;
+}
+
+laplacianSchemes
+{
+ default none;
+ laplacian(DT,T) Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+ default linear;
+}
+
+snGradSchemes
+{
+ default corrected;
+}
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/solid-openfoam/system/fvSolution b/flow-over-heated-plate/solid-openfoam/system/fvSolution
new file mode 100644
index 000000000..8362241bb
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/system/fvSolution
@@ -0,0 +1,35 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| ========= | |
+| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
+| \\ / O peration | Version: 5 |
+| \\ / A nd | Web: www.OpenFOAM.org |
+| \\/ M anipulation | |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object fvSolution;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solvers
+{
+ T
+ {
+ solver PCG;
+ preconditioner DIC;
+ tolerance 1e-06;
+ relTol 0;
+ }
+}
+
+SIMPLE
+{
+ nNonOrthogonalCorrectors 2;
+}
+
+
+// ************************************************************************* //
diff --git a/flow-over-heated-plate/solid-openfoam/system/preciceDict b/flow-over-heated-plate/solid-openfoam/system/preciceDict
new file mode 100644
index 000000000..6d41d9bde
--- /dev/null
+++ b/flow-over-heated-plate/solid-openfoam/system/preciceDict
@@ -0,0 +1,39 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object preciceDict;
+}
+
+preciceConfig "../precice-config.xml";
+
+participant Solid;
+
+modules (CHT);
+
+interfaces
+{
+ Interface1
+ {
+ mesh Solid-Mesh;
+ patches (interface);
+
+ readData
+ (
+ Temperature
+ );
+
+ writeData
+ (
+ Heat-Flux
+ );
+ };
+};
+
+CHT
+{
+ k [ 1 1 -3 -1 0 0 0 ] 100;
+ solverType "basic";
+};
diff --git a/heat-exchanger/README.md b/heat-exchanger/README.md
new file mode 100644
index 000000000..39c1d5de0
--- /dev/null
+++ b/heat-exchanger/README.md
@@ -0,0 +1,47 @@
+---
+title: Heat exchanger
+permalink: tutorials-heat-exchanger.html
+keywords: CHT, OpenFOAM, CalculiX
+summary: Tutorial for a shell-and-tube heat exchanger, using OpenFOAM and CalculiX
+---
+
+This tutorial describes how to run a conjugate heat transfer simulation with two separate OpenFOAM solvers and CalculiX. The files for this tutorial are located in this repository (directory CHT/heat_exchanger).
+
+This tutorial is based on [a case](https://www.simscale.com/projects/cheunglucia/heat_exchanger_-_cht_simulation/) prepared with [SimScale](https://www.simscale.com/) by [Lucia Cheung Yau](https://github.com/ludcila) for her [Master's Thesis](https://www5.in.tum.de/pub/Cheung2016_Thesis.pdf).
+
+
+## Setup
+
+This scenario consists of two fluid and one solid participant and represents a [shell-and-tube heat exchanger](https://en.wikipedia.org/wiki/Shell_and_tube_heat_exchanger). The geometry includes an (adiabatic) shell, in which an _inner fluid_ flows. It enters from the top-right inlet and exits from the bottom-left, after getting redirected several times by baffles. The geometry also includes a set of tubes, in which an _outer fluid_ flows from left to right. The two fluids enter in different temperatures and exchange heat through the (thick) solid walls of the tubes. This is a steady-state simulation and the flow is considered laminar.
+
+
+
+We define the participants `Inner-Fluid`, `Solid`, and `Outer-Fluid` and two interfaces: one between the `Inner-Fluid` and `Solid` and one between the `Solid` and `Outer-Fluid`. Parallel-explicit coupling is used on both interfaces as pseudo timestepping to reach steady-state. We use nearest-neighbor mapping between all meshes. The OpenFOAM participants can either be executed in serial, or in parallel.
+
+
+
+## Available solvers
+
+* OpenFOAM. `buoyantSimpleFoam` is used for fluid flow (both participants). This is a solver for steady-state, buoyant, turbulent flow of compressible fluids for ventilation and heat transfer. For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+* CalculiX. For more information, have a look at the [CalculiX adapter documentation](adapter-calculix-overview.html).
+
+## Running the Simulation
+
+{% include note.html content="Since the already prepared case contains mesh files of approx. 50MB in size, we currently host these files outside of the tutorials repository and you can download and extract them automatically in the appropriate locations by running the download-meshes.sh script. You can [help us improve this](https://github.com/precice/tutorials/issues/6)!" %}
+
+Before starting the simulation for the first time you need to download the mesh files and copy them into the appropriate location. The shell script `./download-meshes.sh` will handle these things automatically. Afterwards, the simulation setup is ready to run.
+
+In order to run the coupled simulation, you can simply step into the participant directories and execute`./run.sh` (or `./run.sh -parallel` for running a fluid participant in parallel). The simulation will need several minutes or up to an hour on a laptop to end (t=500). Before repeating the simulation, you can use the `clean-tutorial.sh` script to clean-up any previous results and log files.
+
+## Post-processing
+
+After the first results are written (a new time directory will be created), you may visualize the results.
+
+For the OpenFOAM results, you can use ParaView and open the allready-provided `fluid-inner-openfoam.foam` and `fluid-outer-openfoam.foam` files. You can then group the two cases and visualize them together.
+
+Unfortunately, ParaView does not support CalculiX result files. You may see the results in CGX or convert them using 3rd-party tools.
+
+
+
+{% include disclaimer.html content="This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks." %}
diff --git a/heat-exchanger/clean-tutorial.sh b/heat-exchanger/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/heat-exchanger/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Download_meshes b/heat-exchanger/download-meshes.sh
similarity index 61%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Download_meshes
rename to heat-exchanger/download-meshes.sh
index 9165b3d87..00b205be0 100755
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Download_meshes
+++ b/heat-exchanger/download-meshes.sh
@@ -1,5 +1,4 @@
#!/bin/sh
-cd ${0%/*} || exit 1 # Run from this directory
echo "This tutorial is based on a case prepared with SimScale."
echo "Since the mesh files are several MB large, we don't store them in the Git repository."
@@ -8,11 +7,16 @@ echo ""
echo "Downloading the Solid case..."
wget -nv -O - https://syncandshare.lrz.de/dl/fi3c9Xt5UzBc5hJvXzsLBHXn/Solid.tar.gz | tar -xzv
+mv ./Solid/* solid-calculix
+rm -r ./Solid
+sed -i 's/Solid/\./g' solid-calculix/solid.inp
echo "Downloading and extracting the Inner-Fluid mesh..."
-wget -nv -O - https://syncandshare.lrz.de/dl/fiNsYGC1DKzgio4jS5NhsXg7/polyMesh.org.tar.gz | tar -xzv -C Inner-Fluid/constant
+wget -nv -O - https://syncandshare.lrz.de/dl/fiNsYGC1DKzgio4jS5NhsXg7/polyMesh.org.tar.gz | tar -xzv -C fluid-inner-openfoam/constant
+mv fluid-inner-openfoam/constant/polyMesh.org fluid-inner-openfoam/constant/polyMesh
echo "Downloading and extracting the Outer-Fluid mesh..."
-wget -nv -O - https://syncandshare.lrz.de/dl/fiEZRQ8rcVWRkoyZvANim1R1/polyMesh.org.tar.gz | tar -xzv -C Outer-Fluid/constant
+wget -nv -O - https://syncandshare.lrz.de/dl/fiEZRQ8rcVWRkoyZvANim1R1/polyMesh.org.tar.gz | tar -xzv -C fluid-outer-openfoam/constant
+mv fluid-outer-openfoam/constant/polyMesh.org fluid-outer-openfoam/constant/polyMesh
echo "Completed."
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/T b/heat-exchanger/fluid-inner-openfoam/0/T
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/T
rename to heat-exchanger/fluid-inner-openfoam/0/T
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/U b/heat-exchanger/fluid-inner-openfoam/0/U
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/U
rename to heat-exchanger/fluid-inner-openfoam/0/U
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/alphat b/heat-exchanger/fluid-inner-openfoam/0/alphat
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/alphat
rename to heat-exchanger/fluid-inner-openfoam/0/alphat
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/epsilon b/heat-exchanger/fluid-inner-openfoam/0/epsilon
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/epsilon
rename to heat-exchanger/fluid-inner-openfoam/0/epsilon
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/k b/heat-exchanger/fluid-inner-openfoam/0/k
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/k
rename to heat-exchanger/fluid-inner-openfoam/0/k
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/nut b/heat-exchanger/fluid-inner-openfoam/0/nut
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/nut
rename to heat-exchanger/fluid-inner-openfoam/0/nut
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/p b/heat-exchanger/fluid-inner-openfoam/0/p
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/p
rename to heat-exchanger/fluid-inner-openfoam/0/p
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/p_rgh b/heat-exchanger/fluid-inner-openfoam/0/p_rgh
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/0/p_rgh
rename to heat-exchanger/fluid-inner-openfoam/0/p_rgh
diff --git a/heat-exchanger/fluid-inner-openfoam/clean.sh b/heat-exchanger/fluid-inner-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/heat-exchanger/fluid-inner-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/heat-exchanger/fluid-inner-openfoam/constant/.gitignore b/heat-exchanger/fluid-inner-openfoam/constant/.gitignore
new file mode 100644
index 000000000..825968042
--- /dev/null
+++ b/heat-exchanger/fluid-inner-openfoam/constant/.gitignore
@@ -0,0 +1 @@
+polyMesh/
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/g b/heat-exchanger/fluid-inner-openfoam/constant/g
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/g
rename to heat-exchanger/fluid-inner-openfoam/constant/g
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/radiationProperties b/heat-exchanger/fluid-inner-openfoam/constant/radiationProperties
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/radiationProperties
rename to heat-exchanger/fluid-inner-openfoam/constant/radiationProperties
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/thermophysicalProperties b/heat-exchanger/fluid-inner-openfoam/constant/thermophysicalProperties
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/thermophysicalProperties
rename to heat-exchanger/fluid-inner-openfoam/constant/thermophysicalProperties
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/turbulenceProperties b/heat-exchanger/fluid-inner-openfoam/constant/turbulenceProperties
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/constant/turbulenceProperties
rename to heat-exchanger/fluid-inner-openfoam/constant/turbulenceProperties
diff --git a/heat-exchanger/fluid-inner-openfoam/run.sh b/heat-exchanger/fluid-inner-openfoam/run.sh
new file mode 100755
index 000000000..6f176ba93
--- /dev/null
+++ b/heat-exchanger/fluid-inner-openfoam/run.sh
@@ -0,0 +1,7 @@
+#!/bin/sh
+set -e -u
+
+touch fluid-inner-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/controlDict b/heat-exchanger/fluid-inner-openfoam/system/controlDict
similarity index 88%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/controlDict
rename to heat-exchanger/fluid-inner-openfoam/system/controlDict
index 9545a03ce..fde22f262 100644
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/controlDict
+++ b/heat-exchanger/fluid-inner-openfoam/system/controlDict
@@ -4,7 +4,7 @@ FoamFile {
object controlDict;
format ascii;
}
-application chtMultiRegionSimpleFoam;
+application buoyantSimpleFoam;
startFrom startTime;
stopAt endTime;
writeFormat ascii;
@@ -12,7 +12,7 @@ writePrecision 12;
writeCompression on;
timeFormat general;
timePrecision 12;
-runTimeModifiable yes;
+runTimeModifiable false;
deltaT 1;
startTime 0.0;
writeInterval 50;
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/decomposeParDict b/heat-exchanger/fluid-inner-openfoam/system/decomposeParDict
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/decomposeParDict
rename to heat-exchanger/fluid-inner-openfoam/system/decomposeParDict
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/fvOptions b/heat-exchanger/fluid-inner-openfoam/system/fvOptions
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/fvOptions
rename to heat-exchanger/fluid-inner-openfoam/system/fvOptions
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/fvSchemes b/heat-exchanger/fluid-inner-openfoam/system/fvSchemes
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/fvSchemes
rename to heat-exchanger/fluid-inner-openfoam/system/fvSchemes
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/fvSolution b/heat-exchanger/fluid-inner-openfoam/system/fvSolution
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/fvSolution
rename to heat-exchanger/fluid-inner-openfoam/system/fvSolution
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/preciceDict b/heat-exchanger/fluid-inner-openfoam/system/preciceDict
similarity index 65%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/preciceDict
rename to heat-exchanger/fluid-inner-openfoam/system/preciceDict
index 27d9a2dc7..56ae9b4f5 100644
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/preciceDict
+++ b/heat-exchanger/fluid-inner-openfoam/system/preciceDict
@@ -7,9 +7,9 @@ FoamFile
object preciceDict;
}
-preciceConfig "precice-config.xml";
+preciceConfig "../precice-config.xml";
-participant Outer-Fluid;
+participant Fluid-Inner;
modules (CHT);
@@ -17,7 +17,7 @@ interfaces
{
Interface1
{
- mesh Outer-Fluid-to-Solid;
+ mesh Fluid-Inner-to-Solid;
patches (interface);
readData
@@ -28,8 +28,8 @@ interfaces
writeData
(
- Sink-Temperature-Outer-Fluid
- Heat-Transfer-Coefficient-Outer-Fluid
+ Sink-Temperature-Fluid-Inner
+ Heat-Transfer-Coefficient-Fluid-Inner
);
};
-};
\ No newline at end of file
+};
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/T b/heat-exchanger/fluid-outer-openfoam/0/T
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/T
rename to heat-exchanger/fluid-outer-openfoam/0/T
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/U b/heat-exchanger/fluid-outer-openfoam/0/U
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/U
rename to heat-exchanger/fluid-outer-openfoam/0/U
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/alphat b/heat-exchanger/fluid-outer-openfoam/0/alphat
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/alphat
rename to heat-exchanger/fluid-outer-openfoam/0/alphat
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/epsilon b/heat-exchanger/fluid-outer-openfoam/0/epsilon
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/epsilon
rename to heat-exchanger/fluid-outer-openfoam/0/epsilon
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/k b/heat-exchanger/fluid-outer-openfoam/0/k
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/k
rename to heat-exchanger/fluid-outer-openfoam/0/k
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/nut b/heat-exchanger/fluid-outer-openfoam/0/nut
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/nut
rename to heat-exchanger/fluid-outer-openfoam/0/nut
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/p b/heat-exchanger/fluid-outer-openfoam/0/p
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/p
rename to heat-exchanger/fluid-outer-openfoam/0/p
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/p_rgh b/heat-exchanger/fluid-outer-openfoam/0/p_rgh
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/0/p_rgh
rename to heat-exchanger/fluid-outer-openfoam/0/p_rgh
diff --git a/heat-exchanger/fluid-outer-openfoam/clean.sh b/heat-exchanger/fluid-outer-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/heat-exchanger/fluid-outer-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/heat-exchanger/fluid-outer-openfoam/constant/.gitignore b/heat-exchanger/fluid-outer-openfoam/constant/.gitignore
new file mode 100644
index 000000000..825968042
--- /dev/null
+++ b/heat-exchanger/fluid-outer-openfoam/constant/.gitignore
@@ -0,0 +1 @@
+polyMesh/
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/g b/heat-exchanger/fluid-outer-openfoam/constant/g
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/g
rename to heat-exchanger/fluid-outer-openfoam/constant/g
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/radiationProperties b/heat-exchanger/fluid-outer-openfoam/constant/radiationProperties
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/radiationProperties
rename to heat-exchanger/fluid-outer-openfoam/constant/radiationProperties
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/thermophysicalProperties b/heat-exchanger/fluid-outer-openfoam/constant/thermophysicalProperties
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/thermophysicalProperties
rename to heat-exchanger/fluid-outer-openfoam/constant/thermophysicalProperties
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/turbulenceProperties b/heat-exchanger/fluid-outer-openfoam/constant/turbulenceProperties
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/constant/turbulenceProperties
rename to heat-exchanger/fluid-outer-openfoam/constant/turbulenceProperties
diff --git a/heat-exchanger/fluid-outer-openfoam/run.sh b/heat-exchanger/fluid-outer-openfoam/run.sh
new file mode 100755
index 000000000..8816441f2
--- /dev/null
+++ b/heat-exchanger/fluid-outer-openfoam/run.sh
@@ -0,0 +1,7 @@
+#!/bin/sh
+set -e -u
+
+touch fluid-outer-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/controlDict b/heat-exchanger/fluid-outer-openfoam/system/controlDict
similarity index 88%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/controlDict
rename to heat-exchanger/fluid-outer-openfoam/system/controlDict
index 9545a03ce..fde22f262 100644
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/controlDict
+++ b/heat-exchanger/fluid-outer-openfoam/system/controlDict
@@ -4,7 +4,7 @@ FoamFile {
object controlDict;
format ascii;
}
-application chtMultiRegionSimpleFoam;
+application buoyantSimpleFoam;
startFrom startTime;
stopAt endTime;
writeFormat ascii;
@@ -12,7 +12,7 @@ writePrecision 12;
writeCompression on;
timeFormat general;
timePrecision 12;
-runTimeModifiable yes;
+runTimeModifiable false;
deltaT 1;
startTime 0.0;
writeInterval 50;
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/decomposeParDict b/heat-exchanger/fluid-outer-openfoam/system/decomposeParDict
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/decomposeParDict
rename to heat-exchanger/fluid-outer-openfoam/system/decomposeParDict
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/fvOptions b/heat-exchanger/fluid-outer-openfoam/system/fvOptions
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/fvOptions
rename to heat-exchanger/fluid-outer-openfoam/system/fvOptions
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/fvSchemes b/heat-exchanger/fluid-outer-openfoam/system/fvSchemes
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/fvSchemes
rename to heat-exchanger/fluid-outer-openfoam/system/fvSchemes
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/fvSolution b/heat-exchanger/fluid-outer-openfoam/system/fvSolution
similarity index 100%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Outer-Fluid/system/fvSolution
rename to heat-exchanger/fluid-outer-openfoam/system/fvSolution
diff --git a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/preciceDict b/heat-exchanger/fluid-outer-openfoam/system/preciceDict
similarity index 65%
rename from CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/preciceDict
rename to heat-exchanger/fluid-outer-openfoam/system/preciceDict
index 4004345f9..c78c8fe1a 100644
--- a/CHT/heat_exchanger/buoyantSimpleFoam-CalculiX/Inner-Fluid/system/preciceDict
+++ b/heat-exchanger/fluid-outer-openfoam/system/preciceDict
@@ -7,9 +7,9 @@ FoamFile
object preciceDict;
}
-preciceConfig "precice-config.xml";
+preciceConfig "../precice-config.xml";
-participant Inner-Fluid;
+participant Fluid-Outer;
modules (CHT);
@@ -17,7 +17,7 @@ interfaces
{
Interface1
{
- mesh Inner-Fluid-to-Solid;
+ mesh Fluid-Outer-to-Solid;
patches (interface);
readData
@@ -28,8 +28,8 @@ interfaces
writeData
(
- Sink-Temperature-Inner-Fluid
- Heat-Transfer-Coefficient-Inner-Fluid
+ Sink-Temperature-Fluid-Outer
+ Heat-Transfer-Coefficient-Fluid-Outer
);
};
-};
\ No newline at end of file
+};
diff --git a/heat-exchanger/images/tutorials-heat-exchanger-geometry.png b/heat-exchanger/images/tutorials-heat-exchanger-geometry.png
new file mode 100644
index 000000000..31892f08e
Binary files /dev/null and b/heat-exchanger/images/tutorials-heat-exchanger-geometry.png differ
diff --git a/heat-exchanger/images/tutorials-heat-exchanger-participants.png b/heat-exchanger/images/tutorials-heat-exchanger-participants.png
new file mode 100644
index 000000000..06d89251d
Binary files /dev/null and b/heat-exchanger/images/tutorials-heat-exchanger-participants.png differ
diff --git a/heat-exchanger/images/tutorials-heat-exchanger-visualization.png b/heat-exchanger/images/tutorials-heat-exchanger-visualization.png
new file mode 100644
index 000000000..9531a2aab
Binary files /dev/null and b/heat-exchanger/images/tutorials-heat-exchanger-visualization.png differ
diff --git a/heat-exchanger/precice-config.xml b/heat-exchanger/precice-config.xml
new file mode 100644
index 000000000..c1006a1ca
--- /dev/null
+++ b/heat-exchanger/precice-config.xml
@@ -0,0 +1,163 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/heat-exchanger/solid-calculix/.gitignore b/heat-exchanger/solid-calculix/.gitignore
new file mode 100644
index 000000000..b138a63c9
--- /dev/null
+++ b/heat-exchanger/solid-calculix/.gitignore
@@ -0,0 +1,10 @@
+# Files distributed separately, downloaded via download-meshes.sh
+adiabatic.dfl
+all.msh
+inner-interface.flm
+inner-interface.nam
+inner-interface.sur
+outer-interface.flm
+outer-interface.nam
+outer-interface.sur
+solid.inp
diff --git a/heat-exchanger/solid-calculix/clean.sh b/heat-exchanger/solid-calculix/clean.sh
new file mode 100755
index 000000000..e93f04f3c
--- /dev/null
+++ b/heat-exchanger/solid-calculix/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_calculix .
diff --git a/heat-exchanger/solid-calculix/config.yml b/heat-exchanger/solid-calculix/config.yml
new file mode 100644
index 000000000..056eba226
--- /dev/null
+++ b/heat-exchanger/solid-calculix/config.yml
@@ -0,0 +1,14 @@
+participants:
+ # The configuration files for the Fluid-Inner and Fluid-Outer participants
+ # are located in each participant's directory.
+ Solid:
+ interfaces:
+ - mesh: Solid-to-Fluid-Inner
+ patch: inner-interface
+ read-data: [Sink-Temperature-Fluid-Inner, Heat-Transfer-Coefficient-Fluid-Inner]
+ write-data: [Sink-Temperature-Solid, Heat-Transfer-Coefficient-Solid]
+ - mesh: Solid-to-Fluid-Outer
+ patch: outer-interface
+ read-data: [Sink-Temperature-Fluid-Outer, Heat-Transfer-Coefficient-Fluid-Outer]
+ write-data: [Sink-Temperature-Solid, Heat-Transfer-Coefficient-Solid]
+precice-config-file: ../precice-config.xml
diff --git a/heat-exchanger/solid-calculix/run.sh b/heat-exchanger/solid-calculix/run.sh
new file mode 100755
index 000000000..33d6d65c3
--- /dev/null
+++ b/heat-exchanger/solid-calculix/run.sh
@@ -0,0 +1,11 @@
+#!/bin/sh
+set -e -u
+
+if [ ! -f all.msh ]; then
+ echo "Mesh files not found. Use the Download_meshes script to download them."
+ exit
+fi
+
+export OMP_NUM_THREADS=1
+export CCX_NPROC_EQUATION_SOLVER=1
+ccx_preCICE -i solid -precice-participant Solid
diff --git a/multiple-perpendicular-flaps/README.md b/multiple-perpendicular-flaps/README.md
new file mode 100644
index 000000000..22353b653
--- /dev/null
+++ b/multiple-perpendicular-flaps/README.md
@@ -0,0 +1,101 @@
+---
+title: Muliple perpendicular flaps
+permalink: tutorials-multiple-perpendicular-flaps.html
+keywords: multi-coupling, OpenFOAM, deal.II, FSI
+summary: In this case, a fluid and two solids are coupled together using a fully-implicit multi-coupling scheme.
+---
+
+## Case Setup
+
+In the following tutorial we model a fluid flowing through a channel. Two solid, elastic flaps are fixed to the floor of this channel. The flaps oscillate due to the fluid pressure building up on its surface. In this case, a fluid and two solids are coupled together using a fully-implicit multi-coupling scheme. The case setup is shown here:
+
+
+
+The simulated flow domain is 6 units long (x) and 4 units tall (z). The flaps are clamped at the bottom (z=0) and they are 1 unit tall (z), 0.1 units long (x), and 0.3 units wide (y). Being located at x=-1 and x=1, the flaps split the domain into three equal parts.
+
+This is a quasi-2D simulation, with one cell in width and empty conditions are imposed on the front and back.
+
+The inflow velocity is 5 m/s (uniform) on the left boundary.
+At the outlet, pressure is set to zero and velocity to `zeroGradient`.
+The top, bottom and flap are walls with a `noslip` condition.
+
+For a case showing fluid-structure interaction only (no multi-coupling), take a look at the [single perpendicular flap tutorial](tutorials-perpendicular-flap.html).
+
+## Why multi-coupling?
+
+This is a case with three participants: the fluid and each flap. In preCICE, there are two options to [couple more than two participants](configuration-coupling-multi.html). The first option a composition of bi-coupling schemes, in which we must specify the exchange of data in a participant to participant manner. However, such a composition is not suited for combining multiple strong fluid-structure interations [1]. Thus, in this case, we use the second option, fully-implicit multi-coupling.
+
+We can set this in our `precice-config.xml`:
+
+```xml
+
+
+
+
+```
+
+The participant that has the control is the one that it is connected to all other participants. This is why we have chosen the fluid participant for this task.
+
+## About the Solvers
+
+For the fluid participant we use OpenFOAM. In particular, we use the application `pimpleFoam`. The geometry of the Fluid participant is defined in the file `Fluid/system/blockMeshDict`. Besides, we must specify where are we exchanging data with the other participants. The interfaces are set in the file `Fluid/system/preciceDict`. In this file, we set to exchange stress and displacement on the surface of each flap.
+
+Most of the coupling details are specified in the file `precide-config.xml`. Here we estipulate the order in which we read/write data from one participant to another or how we map from the fluid to the solid's mesh. In particular, we have choosen the nearest-neighbor mapping scheme.
+
+For the simulation of the solid participants we use the deal.II adapter. In deal.II, the geometry of the domain is specified directly on the solver. The two flaps in our case are essentially the same but for the x-coordinate. The flap geometry is given to the solver when we select the scenario in the '.prm' file.
+
+ ```
+ set Scenario = PF
+ ```
+But to specify the position of the flap along the x-axis, we must specify it in the `Solid1/linear_elasticity.prm` file as follows:
+
+ ```
+ set Flap location = -1.0
+ ```
+While in case of `Solid2/linear_elasticity.prm` we write:
+
+ ```
+ set Flap location = 1.0
+ ```
+The scenario settings are implemented similarly for the nonlinear case.
+
+## Running the Simulation
+1. Preparation:
+ To run the coupled simulation, copy the deal.II executable `linear_elasticity` or `nonlinear_elasticity` into the main folder. To learn how to obtain the deal.II executable take a look at the description on the [deal.II-adapter page](adapter-dealii-overview.html).
+2. Starting:
+
+ We are going to run each solver in a different terminal. It is important that first we navigate to the simulation directory so that all solvers start in the same directory.
+ To start the `Fluid` participant, run:
+ ```
+ cd fluid-openfoam
+ ./run.sh
+ ```
+ to start OpenFOAM in serial or
+ ```
+ cd fluid-openfoam
+ ./run.sh -parallel
+ ```
+ for a parallel run.
+
+ The solid participants are only designed for serial runs. To run the `Solid1` participant, execute the corresponding deal.II binary file e.g. by:
+ ```
+ cd solid-left-dealii
+ ./run.sh -linear
+ ```
+ Finally, in the third terminal we will run the solver for the `Solid2` participant by:
+ ```
+ cd solid-right-dealii
+ ./run.sh -linear
+ ```
+ In case we want to run the nonlinear case, simply replace the flag`-linear` by `-nonlinear`.
+
+## Postprocessing
+
+After the simulation has finished, you can visualize your results using e.g. ParaView. Fluid results are in the OpenFOAM format and you may load the `fluid-openfoam.foam` file. Looking at the fluid results is enough to obtain information about the behaviour of the flaps. You can also visualize the solid participants' vtks though.
+
+
+
+## References
+
+[1] H. Bungartz, F. Linder, M. Mehl, B. Uekerman. A plug-and-play coupling approach for parallel multi-field simulations. 2014.
+
diff --git a/multiple-perpendicular-flaps/clean-tutorial.sh b/multiple-perpendicular-flaps/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/multiple-perpendicular-flaps/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/U b/multiple-perpendicular-flaps/fluid-openfoam/0/U
similarity index 83%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/U
rename to multiple-perpendicular-flaps/fluid-openfoam/0/U
index 9bfbc4ea3..9f67e7a47 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/U
+++ b/multiple-perpendicular-flaps/fluid-openfoam/0/U
@@ -10,7 +10,7 @@ FoamFile
dimensions [0 1 -1 0 0 0 0];
-internalField uniform (10 0 0);
+internalField uniform (5 0 0);
boundaryField
{
@@ -23,7 +23,12 @@ boundaryField
{
type zeroGradient;
}
- flap
+ flap1
+ {
+ type movingWallVelocity;
+ value uniform (0 0 0);
+ }
+ flap2
{
type movingWallVelocity;
value uniform (0 0 0);
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/p b/multiple-perpendicular-flaps/fluid-openfoam/0/p
similarity index 90%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/p
rename to multiple-perpendicular-flaps/fluid-openfoam/0/p
index a558fafcf..ff622213b 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/p
+++ b/multiple-perpendicular-flaps/fluid-openfoam/0/p
@@ -24,7 +24,12 @@ boundaryField
value uniform 0;
}
- flap
+ flap1
+ {
+ type zeroGradient;
+ }
+
+ flap2
{
type zeroGradient;
}
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/phi b/multiple-perpendicular-flaps/fluid-openfoam/0/phi
similarity index 90%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/phi
rename to multiple-perpendicular-flaps/fluid-openfoam/0/phi
index 06c61d9c4..176ef2859 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/phi
+++ b/multiple-perpendicular-flaps/fluid-openfoam/0/phi
@@ -23,7 +23,12 @@ boundaryField
type calculated;
value $internalField;
}
- flap
+ flap1
+ {
+ type calculated;
+ value uniform 0;
+ }
+ flap2
{
type calculated;
value uniform 0;
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement b/multiple-perpendicular-flaps/fluid-openfoam/0/pointDisplacement
similarity index 89%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
rename to multiple-perpendicular-flaps/fluid-openfoam/0/pointDisplacement
index f4644920d..7286c6d38 100644
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
+++ b/multiple-perpendicular-flaps/fluid-openfoam/0/pointDisplacement
@@ -25,31 +25,29 @@ boundaryField
value uniform (0 0 0);
}
- cylinder
+ flap1
{
type fixedValue;
value $internalField;
}
- flap
+
+ flap2
{
type fixedValue;
value $internalField;
}
- top
+ upperWall
{
type slip;
}
- bottom
+ lowerWall
{
type slip;
}
- front
- {
- type empty;
- }
- back
+
+ frontAndBack
{
type empty;
}
diff --git a/multiple-perpendicular-flaps/fluid-openfoam/clean.sh b/multiple-perpendicular-flaps/fluid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/multiple-perpendicular-flaps/fluid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/constant/dynamicMeshDict b/multiple-perpendicular-flaps/fluid-openfoam/constant/dynamicMeshDict
similarity index 78%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/constant/dynamicMeshDict
rename to multiple-perpendicular-flaps/fluid-openfoam/constant/dynamicMeshDict
index d323bc059..2d8f04445 100644
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/constant/dynamicMeshDict
+++ b/multiple-perpendicular-flaps/fluid-openfoam/constant/dynamicMeshDict
@@ -17,6 +17,7 @@ solver displacementLaplacian;
displacementLaplacianCoeffs {
- diffusivity quadratic inverseDistance (flap);
+ diffusivity quadratic inverseDistance (flap1);
+ diffusivity quadratic inverseDistance (flap2);
-}
\ No newline at end of file
+}
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/constant/transportProperties b/multiple-perpendicular-flaps/fluid-openfoam/constant/transportProperties
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/constant/transportProperties
rename to multiple-perpendicular-flaps/fluid-openfoam/constant/transportProperties
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/constant/turbulenceProperties b/multiple-perpendicular-flaps/fluid-openfoam/constant/turbulenceProperties
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/constant/turbulenceProperties
rename to multiple-perpendicular-flaps/fluid-openfoam/constant/turbulenceProperties
diff --git a/multiple-perpendicular-flaps/fluid-openfoam/run.sh b/multiple-perpendicular-flaps/fluid-openfoam/run.sh
new file mode 100755
index 000000000..c191b9e48
--- /dev/null
+++ b/multiple-perpendicular-flaps/fluid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/multiple-perpendicular-flaps/fluid-openfoam/system/blockMeshDict b/multiple-perpendicular-flaps/fluid-openfoam/system/blockMeshDict
new file mode 100644
index 000000000..c58e95294
--- /dev/null
+++ b/multiple-perpendicular-flaps/fluid-openfoam/system/blockMeshDict
@@ -0,0 +1,214 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ object blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+scale 1.;
+
+x0 -3.;
+x1 -1.05;
+x2 -0.95;
+x3 0.95;
+x4 1.05;
+x5 3.;
+
+z0 0.;
+z1 1.;
+z2 4.;
+
+w 0;
+vertices
+(
+ ($x0 $z0 $w ) // 0
+ ($x1 $z0 $w ) // 1
+ ($x2 $z0 $w ) // 2
+ ($x3 $z0 $w ) // 3
+ ($x4 $z0 $w ) // 4
+ ($x5 $z0 $w ) // 5
+
+ ($x0 $z1 $w ) // 6
+ ($x1 $z1 $w ) // 7
+ ($x2 $z1 $w ) // 8
+ ($x3 $z1 $w ) // 9
+ ($x4 $z1 $w ) // 10
+ ($x5 $z1 $w ) // 11
+
+ ($x0 $z2 $w ) // 12
+ ($x1 $z2 $w ) // 13
+ ($x2 $z2 $w ) // 14
+ ($x3 $z2 $w ) // 15
+ ($x4 $z2 $w ) // 16
+ ($x5 $z2 $w ) // 17
+
+ ($x0 $z0 1 ) // 18
+ ($x1 $z0 1 ) // 19
+ ($x2 $z0 1 ) // 20
+ ($x3 $z0 1 ) // 21
+ ($x4 $z0 1 ) // 22
+ ($x5 $z0 1 ) // 23
+ ($x0 $z1 1 ) // 24
+ ($x1 $z1 1 ) // 25
+ ($x2 $z1 1 ) // 26
+ ($x3 $z1 1 ) // 27
+ ($x4 $z1 1 ) // 28
+ ($x5 $z1 1 ) // 29
+ ($x0 $z2 1 ) // 30
+ ($x1 $z2 1 ) // 31
+ ($x2 $z2 1 ) // 32
+ ($x3 $z2 1 ) // 33
+ ($x4 $z2 1 ) // 34
+ ($x5 $z2 1 ) // 35
+
+
+);
+
+// Grading
+h1 20;
+h2 4;
+h3 25;
+v1 20;
+v2 45;
+
+blocks
+(
+ hex ( 0 1 7 6 18 19 25 24 )
+ ($h1 $v1 1 )
+ simpleGrading (0.5 1 1)
+
+ hex ( 2 3 9 8 20 21 27 26 )
+ ($h3 $v1 1)
+ simpleGrading (1 1 1)
+
+ hex ( 4 5 11 10 22 23 29 28 )
+ ($h1 $v1 1)
+ simpleGrading (2 1 1)
+
+
+ hex ( 6 7 13 12 24 25 31 30 )
+ ($h1 $v2 1 )
+ simpleGrading (0.5 1.2 1)
+
+ hex ( 8 9 15 14 26 27 33 32 )
+ ($h3 $v2 1)
+ simpleGrading (1 1.2 1)
+
+ hex ( 10 11 17 16 28 29 35 34 )
+ ($h1 $v2 1)
+ simpleGrading (2 1.2 1)
+
+
+ hex ( 7 8 14 13 25 26 32 31 )
+ ($h2 $v2 1)
+ simpleGrading (1 1.2 1)
+
+ hex ( 9 10 16 15 27 28 34 33 )
+ ($h2 $v2 1)
+ simpleGrading (1 1.2 1)
+
+
+);
+
+edges
+(
+);
+
+boundary
+(
+ inlet
+ {
+ type patch;
+ faces
+ (
+ ( 0 6 24 18 )
+ ( 6 12 30 24 )
+ );
+ }
+ outlet
+ {
+ type patch;
+ faces
+ (
+ ( 5 11 29 23 )
+ ( 11 17 35 29 )
+ );
+ }
+
+ flap1
+ {
+ type wall;
+ faces
+ (
+ ( 1 7 25 19 )
+ ( 7 8 26 25 )
+ ( 8 2 20 26 ) //reverse
+
+ );
+ }
+
+ flap2
+ {
+ type wall;
+ faces
+ (
+ ( 3 9 27 21 )
+ ( 9 10 28 27 )
+ ( 10 4 22 28 ) //reverse
+
+ );
+ }
+
+
+ upperWall
+ {
+ type wall;
+ faces
+ (
+ ( 12 13 31 30 )
+ ( 13 14 32 31 )
+ ( 14 15 33 32 )
+ ( 15 16 34 33 )
+ ( 16 17 35 34 )
+ );
+ }
+ lowerWall
+ {
+ type wall;
+ faces
+ (
+ ( 0 1 19 18 )
+ ( 2 3 21 20 )
+ ( 4 5 23 22 )
+ );
+ }
+ frontAndBack
+ {
+ type empty;
+ faces
+ (
+ ( 0 1 7 6 ) //front bottom
+ ( 2 3 9 8 )
+ ( 4 5 11 10 )
+ ( 6 7 13 12 ) //front top
+ ( 7 8 14 13 )
+ ( 8 9 15 14 )
+ ( 9 10 16 15 )
+ ( 10 11 17 16 )
+
+
+ ( 18 19 25 24 ) //back bottom
+ ( 20 21 27 26 )
+ ( 22 23 29 28 )
+ ( 24 25 31 30 ) // back top
+ ( 25 26 32 31 )
+ ( 26 27 33 32 )
+ ( 27 28 34 33 )
+ ( 28 29 35 34 )
+ );
+ }
+);
+
+// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/controlDict b/multiple-perpendicular-flaps/fluid-openfoam/system/controlDict
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/controlDict
rename to multiple-perpendicular-flaps/fluid-openfoam/system/controlDict
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/decomposeParDict b/multiple-perpendicular-flaps/fluid-openfoam/system/decomposeParDict
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/decomposeParDict
rename to multiple-perpendicular-flaps/fluid-openfoam/system/decomposeParDict
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/fvSchemes b/multiple-perpendicular-flaps/fluid-openfoam/system/fvSchemes
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/fvSchemes
rename to multiple-perpendicular-flaps/fluid-openfoam/system/fvSchemes
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/fvSolution b/multiple-perpendicular-flaps/fluid-openfoam/system/fvSolution
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/system/fvSolution
rename to multiple-perpendicular-flaps/fluid-openfoam/system/fvSolution
diff --git a/multiple-perpendicular-flaps/fluid-openfoam/system/preciceDict b/multiple-perpendicular-flaps/fluid-openfoam/system/preciceDict
new file mode 100644
index 000000000..f53de6925
--- /dev/null
+++ b/multiple-perpendicular-flaps/fluid-openfoam/system/preciceDict
@@ -0,0 +1,86 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object preciceDict;
+}
+
+preciceConfig "../precice-config.xml";
+
+participant Fluid;
+
+modules (FSI);
+
+interfaces
+{
+ Interface1
+ {
+ mesh Fluid1-Mesh-Centers;
+ patches (flap1);
+ locations faceCenters;
+
+ readData
+ (
+ );
+
+ writeData
+ (
+ Stress1
+ );
+ };
+
+ Interface2
+ {
+ mesh Fluid1-Mesh-Nodes;
+ patches (flap1);
+ locations faceNodes;
+
+ readData
+ (
+ Displacement1
+ );
+
+ writeData
+ (
+ );
+ };
+
+ Interface3
+ {
+ mesh Fluid2-Mesh-Centers;
+ patches (flap2);
+ locations faceCenters;
+
+ readData
+ (
+ );
+
+ writeData
+ (
+ Stress2
+ );
+ };
+
+ Interface4
+ {
+ mesh Fluid2-Mesh-Nodes;
+ patches (flap2);
+ locations faceNodes;
+
+ readData
+ (
+ Displacement2
+ );
+
+ writeData
+ (
+ );
+ };
+};
+
+FSI
+{
+ rho rho [1 -3 0 0 0 0 0] 1;
+}
diff --git a/multiple-perpendicular-flaps/images/tutorials-multiple-perpendicular-flaps-results.png b/multiple-perpendicular-flaps/images/tutorials-multiple-perpendicular-flaps-results.png
new file mode 100644
index 000000000..aedc406db
Binary files /dev/null and b/multiple-perpendicular-flaps/images/tutorials-multiple-perpendicular-flaps-results.png differ
diff --git a/multiple-perpendicular-flaps/images/tutorials-multiple-perpendicular-flaps-setup-two-flaps.png b/multiple-perpendicular-flaps/images/tutorials-multiple-perpendicular-flaps-setup-two-flaps.png
new file mode 100644
index 000000000..a8a124666
Binary files /dev/null and b/multiple-perpendicular-flaps/images/tutorials-multiple-perpendicular-flaps-setup-two-flaps.png differ
diff --git a/multiple-perpendicular-flaps/precice-config.xml b/multiple-perpendicular-flaps/precice-config.xml
new file mode 100644
index 000000000..e21b46e4c
--- /dev/null
+++ b/multiple-perpendicular-flaps/precice-config.xml
@@ -0,0 +1,123 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/multiple-perpendicular-flaps/solid-left-dealii/clean.sh b/multiple-perpendicular-flaps/solid-left-dealii/clean.sh
new file mode 100755
index 000000000..9ad81b8fb
--- /dev/null
+++ b/multiple-perpendicular-flaps/solid-left-dealii/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_dealii .
diff --git a/multiple-perpendicular-flaps/solid-left-dealii/parameters.prm b/multiple-perpendicular-flaps/solid-left-dealii/parameters.prm
new file mode 100644
index 000000000..03789c384
--- /dev/null
+++ b/multiple-perpendicular-flaps/solid-left-dealii/parameters.prm
@@ -0,0 +1,84 @@
+# Listing of Parameters
+# Dimensional quantities are in SI units
+# --------------------------------------
+
+subsection Time
+ # End time
+ set End time = 5
+
+ # Time step size
+ set Time step size = 0.01
+
+ # Write results every x timesteps
+ set Output interval = 10
+
+ # Output folder
+ set Output folder = dealii-output
+end
+
+subsection Discretization
+ # Polynomial degree of the FE system
+ set Polynomial degree = 4
+end
+
+subsection System properties
+ # Poisson's ratio
+ set Poisson's ratio = 0.3
+
+ # Shear modulus
+ set Shear modulus = 1538462
+
+ # Density
+ set rho = 3000
+
+ # Body forces x,y,z
+ set body forces = 0.0,0.0,0.0
+end
+
+subsection Solver
+ # Structural model to be used: linear or neo-Hookean
+ set Model = linear
+
+ # Linear solver: CG or Direct
+ set Solver type = Direct
+
+ # Max CG solver iterations (multiples of the system matrix size)
+ # In 2D, this value is best set at 2. In 3D, a value of 1 works fine.
+ set Max iteration multiplier = 1
+
+ # Relative drop criterion for CG solver residual (multiplied by residual norm, ignored if Model == linear or solver == direct)
+ # Hard-coded to absolute criterion of 1e-10 for the linear model.
+ set Residual = 1e-6
+
+ # Number of Newton-Raphson iterations allowed (ignored if Model == linear)
+ set Max iterations Newton-Raphson = 10
+
+ # Relative displacement error tolerance for non-linear iteration (ignored if Model == linear)
+ set Tolerance displacement = 1.0e-6
+
+ # Relative force residual tolerance for non-linear iteration (ignored if Model == linear)
+ set Tolerance force = 1.0e-9
+end
+
+subsection precice configuration
+ # Cases: FSI3 or PF for perpendicular flap
+ set Scenario = PF
+
+ # Name of the precice configuration file
+ set precice config-file = ../precice-config.xml
+
+ # Name of the participant in the precice-config.xml file
+ set Participant name = Solid1
+
+ # Name of the coupling mesh in the precice-config.xml file
+ set Mesh name = Solid1-Mesh
+
+ # Name of the read data in the precice-config.xml file
+ set Read data name = Stress1
+
+ # Name of the write data in the precice-config.xml file
+ set Write data name = Displacement1
+
+ # PF x-location
+ set Flap location = -1.0
+end
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/plotDisplacement.sh b/multiple-perpendicular-flaps/solid-left-dealii/plot-displacement.sh
similarity index 54%
rename from FSI/flap_perp_2D/SU2-FEniCS/plotDisplacement.sh
rename to multiple-perpendicular-flaps/solid-left-dealii/plot-displacement.sh
index 4cf2acf95..fca87fafb 100755
--- a/FSI/flap_perp_2D/SU2-FEniCS/plotDisplacement.sh
+++ b/multiple-perpendicular-flaps/solid-left-dealii/plot-displacement.sh
@@ -1,8 +1,9 @@
-#! /bin/bash
+#!/bin/sh
gnuplot -p << EOF
set grid
set title 'Displacement of the Flap Tip'
set xlabel 'Time [s]'
set ylabel 'X-Displacement [m]'
-plot "precice-FEniCS-watchpoint-point1.log" using 1:5 smooth cumulative title ""
+plot "precice-Solid1-watchpoint-flap_tip.log" using 1:4 title 'Top displacemement' with lines
EOF
+
diff --git a/multiple-perpendicular-flaps/solid-left-dealii/run.sh b/multiple-perpendicular-flaps/solid-left-dealii/run.sh
new file mode 120000
index 000000000..3db351e72
--- /dev/null
+++ b/multiple-perpendicular-flaps/solid-left-dealii/run.sh
@@ -0,0 +1 @@
+../../tools/run-dealii.sh
\ No newline at end of file
diff --git a/multiple-perpendicular-flaps/solid-right-dealii/clean.sh b/multiple-perpendicular-flaps/solid-right-dealii/clean.sh
new file mode 100755
index 000000000..9ad81b8fb
--- /dev/null
+++ b/multiple-perpendicular-flaps/solid-right-dealii/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_dealii .
diff --git a/multiple-perpendicular-flaps/solid-right-dealii/parameters.prm b/multiple-perpendicular-flaps/solid-right-dealii/parameters.prm
new file mode 100644
index 000000000..19e26b376
--- /dev/null
+++ b/multiple-perpendicular-flaps/solid-right-dealii/parameters.prm
@@ -0,0 +1,84 @@
+# Listing of Parameters
+# Dimensional quantities are in SI units
+# --------------------------------------
+
+subsection Time
+ # End time
+ set End time = 5
+
+ # Time step size
+ set Time step size = 0.01
+
+ # Write results every x timesteps
+ set Output interval = 10
+
+ # Output folder
+ set Output folder = dealii-output
+end
+
+subsection Discretization
+ # Polynomial degree of the FE system
+ set Polynomial degree = 4
+end
+
+subsection System properties
+ # Poisson's ratio
+ set Poisson's ratio = 0.3
+
+ # Shear modulus
+ set Shear modulus = 1538462
+
+ # Density
+ set rho = 3000
+
+ # Body forces x,y,z
+ set body forces = 0.0,0.0,0.0
+end
+
+subsection Solver
+ # Structural model to be used: linear or neo-Hookean
+ set Model = linear
+
+ # Linear solver: CG or Direct
+ set Solver type = Direct
+
+ # Max CG solver iterations (multiples of the system matrix size)
+ # In 2D, this value is best set at 2. In 3D, a value of 1 works fine.
+ set Max iteration multiplier = 1
+
+ # Relative drop criterion for CG solver residual (multiplied by residual norm, ignored if Model == linear or solver == direct)
+ # Hard-coded to absolute criterion of 1e-10 for the linear model.
+ set Residual = 1e-6
+
+ # Number of Newton-Raphson iterations allowed (ignored if Model == linear)
+ set Max iterations Newton-Raphson = 10
+
+ # Relative displacement error tolerance for non-linear iteration (ignored if Model == linear)
+ set Tolerance displacement = 1.0e-6
+
+ # Relative force residual tolerance for non-linear iteration (ignored if Model == linear)
+ set Tolerance force = 1.0e-9
+end
+
+subsection precice configuration
+ # Cases: FSI3 or PF for perpendicular flap
+ set Scenario = PF
+
+ # Name of the precice configuration file
+ set precice config-file = ../precice-config.xml
+
+ # Name of the participant in the precice-config.xml file
+ set Participant name = Solid2
+
+ # Name of the coupling mesh in the precice-config.xml file
+ set Mesh name = Solid2-Mesh
+
+ # Name of the read data in the precice-config.xml file
+ set Read data name = Stress2
+
+ # Name of the write data in the precice-config.xml file
+ set Write data name = Displacement2
+
+ # PF x-location
+ set Flap location = 1.0
+end
diff --git a/FSI/flap_perp/SU2-CalculiX/plotDisplacement.sh b/multiple-perpendicular-flaps/solid-right-dealii/plot-displacement.sh
similarity index 54%
rename from FSI/flap_perp/SU2-CalculiX/plotDisplacement.sh
rename to multiple-perpendicular-flaps/solid-right-dealii/plot-displacement.sh
index 6ccc0bb84..0c71fe9c2 100755
--- a/FSI/flap_perp/SU2-CalculiX/plotDisplacement.sh
+++ b/multiple-perpendicular-flaps/solid-right-dealii/plot-displacement.sh
@@ -1,8 +1,9 @@
-#! /bin/bash
+#!/bin/sh
gnuplot -p << EOF
set grid
set title 'Displacement of the Flap Tip'
set xlabel 'Time [s]'
set ylabel 'X-Displacement [m]'
-plot "point1.watchpoint.txt" using 1:5 smooth cumulative title ""
+plot "precice-Solid2-watchpoint-flap_tip.log" using 1:4 title 'Top displacemement' with lines
EOF
+
diff --git a/multiple-perpendicular-flaps/solid-right-dealii/run.sh b/multiple-perpendicular-flaps/solid-right-dealii/run.sh
new file mode 120000
index 000000000..3db351e72
--- /dev/null
+++ b/multiple-perpendicular-flaps/solid-right-dealii/run.sh
@@ -0,0 +1 @@
+../../tools/run-dealii.sh
\ No newline at end of file
diff --git a/partitioned-elastic-beam/README.md b/partitioned-elastic-beam/README.md
new file mode 100644
index 000000000..573518e16
--- /dev/null
+++ b/partitioned-elastic-beam/README.md
@@ -0,0 +1,29 @@
+---
+title: Partitioned elastic beam
+permalink: tutorials-partitioned-elastic-beam.html
+keywords: Structure-Structure Coupling, CalculiX, solid mechanics
+summary: This tutorial describes how to run a structure-structure interaction simulation with CalculiX running on both sides.
+---
+
+## Setup
+
+We have a rectangular linear elastic beam of dimensions 1 x 1 x 8 m, divided in two subdomains by a splitting plane at z = 6 m. This plane corresponds to the coupling surface. Both ends of the beam (z = 0 and z = 8 m) are fixed. A mechanical load F = -0.001 N is applied constantly along the y-axis onto a small set of nodes near the end of the beam. These boundary conditions can be seen in the input files `beam.inp`. Initial conditions are zero both for position and velocity. Other parameters can be found and customized in the `.inp` files.
+
+
+
+## Available solvers
+
+* CalculiX. CalculiX is used for both structural parts. For more information, have a look at the [CalculiX adapter documentation](adapter-calculix-overview.html) for more.
+
+
+## Running the Simulation
+
+The prepared case already contains configuration and mesh files, so that the simulation is ready to run. You can start the simulation by running the script `./run.sh` located in each participant directory. You will see both participants of the simulation running simultaneously.
+
+## Post-processing
+
+To see an animated visualization of the results, you can run the script `./visualize.py`. It joins the `*.frd` output files of both participants to form a new file with the entire beam. Then, it calls `cgx`, since CalculiX results can only be visualized with this graphic tool. If you want to use e.g. ParaView, you may use converting tools.
+
+
+
+You can open result files directly with `cgx` with the command `cgx beam1.frd`, for instance.
diff --git a/partitioned-elastic-beam/clean-tutorial.sh b/partitioned-elastic-beam/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/partitioned-elastic-beam/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/Calculix1Mesh/all.msh b/partitioned-elastic-beam/dirichlet-calculix/all.msh
old mode 100755
new mode 100644
similarity index 100%
rename from SSI/loaded_beam/CalculiX-CalculiX/Calculix1Mesh/all.msh
rename to partitioned-elastic-beam/dirichlet-calculix/all.msh
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/beam1.inp b/partitioned-elastic-beam/dirichlet-calculix/beam1.inp
old mode 100755
new mode 100644
similarity index 73%
rename from SSI/loaded_beam/CalculiX-CalculiX/beam1.inp
rename to partitioned-elastic-beam/dirichlet-calculix/beam1.inp
index 3364de320..26c4d2148
--- a/SSI/loaded_beam/CalculiX-CalculiX/beam1.inp
+++ b/partitioned-elastic-beam/dirichlet-calculix/beam1.inp
@@ -2,9 +2,9 @@
** Structure: part 1 of cantilever beam.
**
**
-*INCLUDE, INPUT=Calculix1Mesh/all.msh
-*INCLUDE, INPUT=Calculix1Mesh/fix1_beam.nam
-*INCLUDE, INPUT=Calculix1Mesh/interface_beam.nam
+*INCLUDE, INPUT=./all.msh
+*INCLUDE, INPUT=./fix1_beam.nam
+*INCLUDE, INPUT=./interface_beam.nam
*BOUNDARY
FIX, 1, 3
*BOUNDARY
diff --git a/partitioned-elastic-beam/dirichlet-calculix/clean.sh b/partitioned-elastic-beam/dirichlet-calculix/clean.sh
new file mode 100755
index 000000000..e93f04f3c
--- /dev/null
+++ b/partitioned-elastic-beam/dirichlet-calculix/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_calculix .
diff --git a/partitioned-elastic-beam/dirichlet-calculix/config.yml b/partitioned-elastic-beam/dirichlet-calculix/config.yml
new file mode 100644
index 000000000..6cd31537c
--- /dev/null
+++ b/partitioned-elastic-beam/dirichlet-calculix/config.yml
@@ -0,0 +1,9 @@
+participants:
+ Calculix1:
+ interfaces:
+ - nodes-mesh: Calculix-Mesh1
+ patch: surface
+ read-data: [Displacement0]
+ write-data: [Force0]
+
+precice-config-file: ../precice-config.xml
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/Calculix1Mesh/fix1_beam.nam b/partitioned-elastic-beam/dirichlet-calculix/fix1_beam.nam
old mode 100755
new mode 100644
similarity index 100%
rename from SSI/loaded_beam/CalculiX-CalculiX/Calculix1Mesh/fix1_beam.nam
rename to partitioned-elastic-beam/dirichlet-calculix/fix1_beam.nam
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/Calculix1Mesh/interface_beam.nam b/partitioned-elastic-beam/dirichlet-calculix/interface_beam.nam
old mode 100755
new mode 100644
similarity index 100%
rename from SSI/loaded_beam/CalculiX-CalculiX/Calculix1Mesh/interface_beam.nam
rename to partitioned-elastic-beam/dirichlet-calculix/interface_beam.nam
diff --git a/partitioned-elastic-beam/dirichlet-calculix/run.sh b/partitioned-elastic-beam/dirichlet-calculix/run.sh
new file mode 100755
index 000000000..4e020fcd1
--- /dev/null
+++ b/partitioned-elastic-beam/dirichlet-calculix/run.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+export OMP_NUM_THREADS=1
+export CCX_NPROC_EQUATION_SOLVER=1
+ccx_preCICE -i beam1 -precice-participant Calculix1
diff --git a/partitioned-elastic-beam/images/tutorials-partitioned-elastic-beam-results.png b/partitioned-elastic-beam/images/tutorials-partitioned-elastic-beam-results.png
new file mode 100644
index 000000000..7aacf1683
Binary files /dev/null and b/partitioned-elastic-beam/images/tutorials-partitioned-elastic-beam-results.png differ
diff --git a/partitioned-elastic-beam/images/tutorials-partitioned-elastic-beam-setup.png b/partitioned-elastic-beam/images/tutorials-partitioned-elastic-beam-setup.png
new file mode 100644
index 000000000..1fc40f556
Binary files /dev/null and b/partitioned-elastic-beam/images/tutorials-partitioned-elastic-beam-setup.png differ
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/Calculix2Mesh/all.msh b/partitioned-elastic-beam/neumann-calculix/all.msh
old mode 100755
new mode 100644
similarity index 100%
rename from SSI/loaded_beam/CalculiX-CalculiX/Calculix2Mesh/all.msh
rename to partitioned-elastic-beam/neumann-calculix/all.msh
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/beam2.inp b/partitioned-elastic-beam/neumann-calculix/beam2.inp
old mode 100755
new mode 100644
similarity index 78%
rename from SSI/loaded_beam/CalculiX-CalculiX/beam2.inp
rename to partitioned-elastic-beam/neumann-calculix/beam2.inp
index ac37f0d10..8e0e08f35
--- a/SSI/loaded_beam/CalculiX-CalculiX/beam2.inp
+++ b/partitioned-elastic-beam/neumann-calculix/beam2.inp
@@ -2,9 +2,9 @@
** Structure: part 2 of cantilever beam.
**
**
-*INCLUDE, INPUT=Calculix2Mesh/all.msh
-*INCLUDE, INPUT=Calculix2Mesh/fix1_beam.nam
-*INCLUDE, INPUT=Calculix2Mesh/interface_beam.nam
+*INCLUDE, INPUT=./all.msh
+*INCLUDE, INPUT=./fix1_beam.nam
+*INCLUDE, INPUT=./interface_beam.nam
*BOUNDARY
FIX, 1, 3
*NSET, NSET=Nload
diff --git a/partitioned-elastic-beam/neumann-calculix/clean.sh b/partitioned-elastic-beam/neumann-calculix/clean.sh
new file mode 100755
index 000000000..e93f04f3c
--- /dev/null
+++ b/partitioned-elastic-beam/neumann-calculix/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_calculix .
diff --git a/partitioned-elastic-beam/neumann-calculix/config.yml b/partitioned-elastic-beam/neumann-calculix/config.yml
new file mode 100644
index 000000000..793f41626
--- /dev/null
+++ b/partitioned-elastic-beam/neumann-calculix/config.yml
@@ -0,0 +1,9 @@
+participants:
+ Calculix2:
+ interfaces:
+ - nodes-mesh: Calculix-Mesh2
+ patch: surface
+ read-data: [Force0]
+ write-data: [Displacement0]
+
+precice-config-file: ../precice-config.xml
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/Calculix2Mesh/fix1_beam.nam b/partitioned-elastic-beam/neumann-calculix/fix1_beam.nam
old mode 100755
new mode 100644
similarity index 100%
rename from SSI/loaded_beam/CalculiX-CalculiX/Calculix2Mesh/fix1_beam.nam
rename to partitioned-elastic-beam/neumann-calculix/fix1_beam.nam
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/Calculix2Mesh/interface_beam.nam b/partitioned-elastic-beam/neumann-calculix/interface_beam.nam
old mode 100755
new mode 100644
similarity index 100%
rename from SSI/loaded_beam/CalculiX-CalculiX/Calculix2Mesh/interface_beam.nam
rename to partitioned-elastic-beam/neumann-calculix/interface_beam.nam
diff --git a/partitioned-elastic-beam/neumann-calculix/run.sh b/partitioned-elastic-beam/neumann-calculix/run.sh
new file mode 100755
index 000000000..e1730a420
--- /dev/null
+++ b/partitioned-elastic-beam/neumann-calculix/run.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+export OMP_NUM_THREADS=1
+export CCX_NPROC_EQUATION_SOLVER=1
+ccx_preCICE -i beam2 -precice-participant Calculix2
diff --git a/partitioned-elastic-beam/precice-config.xml b/partitioned-elastic-beam/precice-config.xml
new file mode 100644
index 000000000..eea9ea6ac
--- /dev/null
+++ b/partitioned-elastic-beam/precice-config.xml
@@ -0,0 +1,72 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/SSI/loaded_beam/CalculiX-CalculiX/visualize.fbd b/partitioned-elastic-beam/visualize.fbd
similarity index 100%
rename from SSI/loaded_beam/CalculiX-CalculiX/visualize.fbd
rename to partitioned-elastic-beam/visualize.fbd
diff --git a/partitioned-elastic-beam/visualize.py b/partitioned-elastic-beam/visualize.py
new file mode 100755
index 000000000..3f0734a02
--- /dev/null
+++ b/partitioned-elastic-beam/visualize.py
@@ -0,0 +1,132 @@
+#!/usr/bin/python
+
+"""
+Use this script to join the visual results (.frd files) of beam1 and beam2 and visualize them.
+"""
+
+import subprocess
+
+#### params ####
+
+# size of complete node sets
+nsize1 = 201
+nsize2 = 81
+nsizem = 261 # nsize1 + nsize2 - nsize_coupling_surface
+
+# time steps. set in precice-config.xml and .inp files
+nsteps = 50
+
+
+##################################################################
+def join_frd(frd1, frd2):
+ """
+ Append the nodes and elements from frd2 to those in frd1 and write the result in a new frd.
+ """
+ with open(frd1, "r") as f1, open(frd2, "r") as f2, open("beam_full.frd", "w") as fp:
+
+ # copy frd header in new file
+ for i in xrange(11):
+ fp.write(f1.readline())
+ f2.readline()
+
+ # node header (change number of nodes)
+ line_f1 = f1.readline()
+ line_f1 = line_f1[:33] + str(nsizem) + line_f1[36:]
+ fp.write(line_f1)
+ f2.readline()
+
+ # merging node lines. each iteration in the for uses a new line from frd2. lines in frd1 are advanced manually
+ line_f1 = f1.readline()
+ for line_f2 in iter(f2.readline, " -3\n"): # -3 indicates end of line block
+ # same node in both files (interface): write any (assuming their values are correct!!)
+ if line_f1[:13] == line_f2[:13]:
+ if line_f1[2] == "3":
+ continue
+ else:
+ fp.write(line_f1)
+ line_f1 = f1.readline()
+ # sorting lines according to node index
+ elif line_f2 < line_f1:
+ fp.write(line_f2)
+ else:
+ while line_f2 > line_f1:
+ fp.write(line_f1)
+ line_f1 = f1.readline()
+
+ if line_f1[:13] != line_f2[:13]:
+ fp.write(line_f2)
+
+ fp.write(" -3\n")
+
+ # element header (change number of elements)
+ line_f1 = f1.readline()
+ line_f1 = line_f1[:34] + "32" + line_f1[36:]
+ fp.write(line_f1)
+ f2.readline()
+
+ # merge element lines. assuming they are sorted and non-overlapping in frd1 and frd2
+ for line_f1 in iter(f1.readline, " -3\n"):
+ fp.write(line_f1)
+ for line_f2 in iter(f2.readline, " -3\n"):
+ fp.write(line_f2)
+ fp.write(" -3\n")
+
+ # merging blocks of lines for each step
+ for i in xrange(nsteps):
+ print "step", i + 1
+ # step header
+ fp.write(f1.readline())
+ f2.readline()
+ line_f1 = f1.readline()
+ line_f1 = line_f1[:33] + str(nsizem) + line_f1[36:]
+ fp.write(line_f1)
+ f2.readline()
+ for j in xrange(5):
+ fp.write(f1.readline())
+ f2.readline()
+
+ line_f1 = f1.readline()
+ for line_f2 in iter(f2.readline, " -3\n"): # -3 indicates end of line block
+ # same node in both files (interface): write any (assuming their values are correct!!)
+ if line_f1[:13] == line_f2[:13]:
+ if line_f1[2] == "3":
+ continue
+ else:
+ # this is an interface node for both beams. write the mean of the values in beam1 and beam2
+ mean_vals = [(float(x) + float(y)) / 2. for x, y in zip([line_f1[13:25],
+ line_f1[25:37], line_f1[37:49]], [line_f2[13:25], line_f2[25:37], line_f2[37:49]])]
+ fp.writelines(line_f1[:13] +
+ '{:12.5E}'.format(mean_vals[0]) +
+ '{:12.5E}'.format(mean_vals[1]) +
+ '{:12.5E}'.format(mean_vals[2]) +
+ '\n')
+ line_f1 = f1.readline()
+ # sorting lines according to node index
+ elif line_f2 < line_f1:
+ fp.write(line_f2)
+ else:
+ while line_f2[:13] > line_f1[:13]:
+ fp.write(line_f1)
+ line_f1 = f1.readline()
+
+ if line_f1[:13] != line_f2[:13]:
+ fp.write(line_f2)
+ else:
+ mean_vals = [(float(x) + float(y)) / 2. for x, y in zip([line_f1[13:25],
+ line_f1[25:37], line_f1[37:49]], [line_f2[13:25], line_f2[25:37], line_f2[37:49]])]
+ fp.writelines(line_f1[:13] +
+ '{:12.5E}'.format(mean_vals[0]) +
+ '{:12.5E}'.format(mean_vals[1]) +
+ '{:12.5E}'.format(mean_vals[2]) +
+ '\n')
+ line_f1 = f1.readline()
+
+ fp.write(" -3\n")
+
+ fp.write("9999\n") # EOF
+
+
+########################## MAIN #################################
+
+join_frd("dirichlet-calculix/beam1.frd", "neumann-calculix/beam2.frd")
+subprocess.call(["cgx", "-b", "visualize.fbd"])
diff --git a/partitioned-heat-conduction-complex/README.md b/partitioned-heat-conduction-complex/README.md
new file mode 100644
index 000000000..f2893b1b4
--- /dev/null
+++ b/partitioned-heat-conduction-complex/README.md
@@ -0,0 +1,25 @@
+---
+title: Partitioned heat conduction (complex setup)
+permalink: tutorials-partitioned-heat-conduction-complex.html
+keywords: FEniCS, Heat conduction
+summary: This tutorial is the advanced version of the `partitioned-heat-conduction` tutorial. More advanced features and geometries may be used.
+---
+
+## Setup
+
+This case is an advanced version of `partitioned-heat-conduction`. Some advanced features offered by this case:
+
+* Geometries may be chosen arbitrarily. One possibility is to use a circle and a rectangular plate with a hole, but you can also provide your own geometry, if you want.
+* You may combine arbitrary mesh resolutions at the coupling interface.
+* Nearest projection mapping is used.
+* The Dirichlet and Neumann participants may be swapped arbitrarily.
+* The exchanged temperature is still scalar valued, but the heat flux is vector valued.
+* You can decide to use a time dependent heat flux and right-hand side to make the problem more challenging.
+
+## Available solvers and dependencies
+
+See `partitioned-heat-conduction`, only `fenics` is provided as a solver.
+
+## Running the simulation
+
+See `partitioned-heat-conduction`. The additional featured mentioned above can be activated via command line arguments. Please run `python3 fenics/heat.py --help` for a full list of provided arguments.
diff --git a/partitioned-heat-conduction-complex/clean-tutorial.sh b/partitioned-heat-conduction-complex/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/partitioned-heat-conduction-complex/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/HT/partitioned-heat/fenics-fenics/.gitignore b/partitioned-heat-conduction-complex/fenics/.gitignore
similarity index 100%
rename from HT/partitioned-heat/fenics-fenics/.gitignore
rename to partitioned-heat-conduction-complex/fenics/.gitignore
diff --git a/partitioned-heat-conduction-complex/fenics/clean.sh b/partitioned-heat-conduction-complex/fenics/clean.sh
new file mode 100755
index 000000000..3a8b4619d
--- /dev/null
+++ b/partitioned-heat-conduction-complex/fenics/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_fenics .
diff --git a/partitioned-heat-conduction-complex/fenics/errorcomputation.py b/partitioned-heat-conduction-complex/fenics/errorcomputation.py
new file mode 100644
index 000000000..2c9ec7367
--- /dev/null
+++ b/partitioned-heat-conduction-complex/fenics/errorcomputation.py
@@ -0,0 +1,15 @@
+from fenics import inner, assemble, dx, project, sqrt
+
+
+def compute_errors(u_approx, u_ref, v, total_error_tol=10 ** -4):
+ # compute pointwise L2 error
+ error_normalized = (u_ref - u_approx) / u_ref
+ # project onto function space
+ error_pointwise = project(abs(error_normalized), v)
+ # determine L2 norm to estimate total error
+ error_total = sqrt(assemble(inner(error_pointwise, error_pointwise) * dx))
+ error_pointwise.rename("error", " ")
+
+ assert (error_total < total_error_tol)
+
+ return error_total, error_pointwise
diff --git a/HT/partitioned-heat/fenics-fenics/heat.py b/partitioned-heat-conduction-complex/fenics/heat.py
similarity index 78%
rename from HT/partitioned-heat/fenics-fenics/heat.py
rename to partitioned-heat-conduction-complex/fenics/heat.py
index e528dd9d9..dd9d2390a 100644
--- a/HT/partitioned-heat/fenics-fenics/heat.py
+++ b/partitioned-heat-conduction-complex/fenics/heat.py
@@ -29,7 +29,7 @@
File, solve, lhs, rhs, grad, inner, dot, dx, ds, interpolate, VectorFunctionSpace, MeshFunction, MPI
from fenicsprecice import Adapter
from errorcomputation import compute_errors
-from my_enums import ProblemType, Subcycling, DomainPart
+from my_enums import ProblemType, DomainPart
import argparse
import numpy as np
from problem_setup import get_geometry, get_problem_setup
@@ -53,48 +53,27 @@ def determine_gradient(V_g, u, flux):
solve(a == L, flux)
-parser = argparse.ArgumentParser(description='Solving heat equation for simple or complex interface case')
+parser = argparse.ArgumentParser(
+ description='Solving heat equation for simple or complex interface case')
parser.add_argument("-d", "--dirichlet", help="create a dirichlet problem", dest='dirichlet', action='store_true')
parser.add_argument("-n", "--neumann", help="create a neumann problem", dest='neumann', action='store_true')
parser.add_argument("-g", "--gamma", help="parameter gamma to set temporal dependence of heat flux", default=0.0,
type=float)
parser.add_argument("-a", "--arbitrary-coupling-interface",
- help="uses more general, but less exact method for interpolation on coupling interface, see https://github.com/precice/fenics-adapter/milestone/1",
- action='store_true')
+ help="uses more general, but less exact method for interpolation on coupling interface,"
+ "see https://github.com/precice/fenics-adapter/milestone/1", action='store_true')
parser.add_argument("-i", "--interface", metavar="interface_type string", type=str, choices=['simple', 'complex'],
help="Type of coupling interface case to be solved. Options: simple, complex", default="simple")
parser.add_argument("-dom", "--domain", metavar='domain_type string', type=str,
choices=['left', 'right', 'circular', 'rectangle'],
- help="Specifying part of the domain being solved. For simple interface the options are left, right, for complex interface the options are circular, rest")
-
+ help="Specifying part of the domain being solved. "
+ "For simple interface the options are left, right, "
+ "for complex interface the options are circular, rest")
args = parser.parse_args()
-subcycle = Subcycling.NONE
-
-fenics_dt = None
-error_tol = None
-
-# for all scenarios, we assume precice_dt == .1
-if subcycle is Subcycling.NONE and not args.arbitrary_coupling_interface:
- fenics_dt = .1 # time step size
- error_tol = 10 ** -6 # Error is bounded by coupling accuracy. In theory we would obtain the analytical solution.
- print("Subcycling = NO, Arbitrary coupling interface = NO, error tolerance = {}".format(error_tol))
-elif subcycle is Subcycling.NONE and args.arbitrary_coupling_interface:
- fenics_dt = .1 # time step size
- error_tol = 10 ** -3 # error low, if we do not subcycle. In theory we would obtain the analytical solution.
- # TODO For reasons, why we currently still have a relatively high error, see milestone https://github.com/precice/fenics-adapter/milestone/1
- print("Subcycling = NO, Arbitrary coupling interface = YES, error tolerance = {}".format(error_tol))
-elif subcycle is Subcycling.MATCHING:
- fenics_dt = .01 # time step size
- error_tol = 10 ** -2 # error increases. If we use subcycling, we cannot assume that we still get the exact solution.
- # TODO Using waveform relaxation, we should be able to obtain the exact solution here, as well.
- print("Subcycling = YES, Matching. error tolerance = {}".format(error_tol))
-elif subcycle is Subcycling.NONMATCHING:
- fenics_dt = .03 # time step size
- error_tol = 10 ** -1 # error increases. If we use subcycling, we cannot assume that we still get the exact solution.
- # TODO Using waveform relaxation, we should be able to obtain the exact solution here, as well.
- print("Subcycling = YES, Non-matching. error tolerance = {}".format(error_tol))
-
+fenics_dt = .1
+# Error is bounded by coupling accuracy. In theory we can obtain the analytical solution.
+error_tol = 10 ** -6
alpha = 3 # parameter alpha
beta = 1.3 # parameter beta
gamma = args.gamma # parameter gamma, dependence of heat flux on time
@@ -137,8 +116,8 @@ def determine_gradient(V_g, u, flux):
# Define variational problem
u = TrialFunction(V)
v = TestFunction(V)
-f = Expression('beta + gamma*x[0]*x[0] - 2*gamma*t - 2*(1-gamma) - 2*alpha', degree=2, alpha=alpha,
- beta=beta, gamma=gamma, t=0)
+f = Expression('beta + gamma*x[0]*x[0] - 2*gamma*t - 2*(1-gamma) - 2*alpha',
+ degree=2, alpha=alpha, beta=beta, gamma=gamma, t=0)
F = u * v / dt * dx + dot(grad(u), grad(v)) * dx - (u_n / dt + f) * v * dx
bcs = [DirichletBC(V, u_D, remaining_boundary)]
@@ -152,7 +131,10 @@ def determine_gradient(V_g, u, flux):
# modify Neumann boundary condition on coupling interface, modify weak form correspondingly
if not boundary_marker: # there is only 1 Neumann-BC which is at the coupling boundary -> integration over whole boundary
if coupling_expression.is_scalar_valued():
- F += v * coupling_expression * dolfin.ds # this term has to be added to weak form to add a Neumann BC (see e.g. p. 83ff Langtangen, Hans Petter, and Anders Logg. "Solving PDEs in Python The FEniCS Tutorial Volume I." (2016).)
+ # this term has to be added to weak form to add a Neumann BC (see e.g. p.
+ # 83ff Langtangen, Hans Petter, and Anders Logg. "Solving PDEs in Python
+ # The FEniCS Tutorial Volume I." (2016).)
+ F += v * coupling_expression * dolfin.ds
elif coupling_expression.is_vector_valued():
normal = FacetNormal(mesh)
F += -v * dot(normal, coupling_expression) * dolfin.ds
@@ -199,7 +181,8 @@ def determine_gradient(V_g, u, flux):
error_out << error_pointwise
# set t_1 = t_0 + dt, this gives u_D^1
-u_D.t = t + dt(0) # call dt(0) to evaluate FEniCS Constant. Todo: is there a better way?
+# call dt(0) to evaluate FEniCS Constant. Todo: is there a better way?
+u_D.t = t + dt(0)
f.t = t + dt(0)
flux = Function(V_g)
@@ -207,7 +190,8 @@ def determine_gradient(V_g, u, flux):
while precice.is_coupling_ongoing():
- if precice.is_action_required(precice.action_write_iteration_checkpoint()): # write checkpoint
+ # write checkpoint
+ if precice.is_action_required(precice.action_write_iteration_checkpoint()):
precice.store_checkpoint(u_n, t, n)
read_data = precice.read_data()
@@ -235,7 +219,8 @@ def determine_gradient(V_g, u, flux):
precice_dt = precice.advance(dt(0))
- if precice.is_action_required(precice.action_read_iteration_checkpoint()): # roll back to checkpoint
+ # roll back to checkpoint
+ if precice.is_action_required(precice.action_read_iteration_checkpoint()):
u_cp, t_cp, n_cp = precice.retrieve_checkpoint()
u_n.assign(u_cp)
t = t_cp
diff --git a/HT/partitioned-heat/fenics-fenics/my_enums.py b/partitioned-heat-conduction-complex/fenics/my_enums.py
similarity index 51%
rename from HT/partitioned-heat/fenics-fenics/my_enums.py
rename to partitioned-heat-conduction-complex/fenics/my_enums.py
index e94988681..27fc5d9ae 100644
--- a/HT/partitioned-heat/fenics-fenics/my_enums.py
+++ b/partitioned-heat-conduction-complex/fenics/my_enums.py
@@ -1,5 +1,6 @@
from enum import Enum
+
class ProblemType(Enum):
"""
Enum defines problem type. Details see above.
@@ -16,15 +17,3 @@ class DomainPart(Enum):
RIGHT = 2 # right part of domain in simple interface case
CIRCULAR = 3 # circular part of domain in complex interface case
RECTANGLE = 4 # domain excluding circular part of complex interface case
-
-
-class Subcycling(Enum):
- """
- Enum defines which kind of subcycling is used
- """
- NONE = 0 # no subcycling, precice_dt == fenics_dt
- MATCHING = 1 # subcycling, where fenics_dt fits into precice_dt, mod(precice_dt, fenics_dt) == 0
- NONMATCHING = 2 # subcycling, where fenics_dt does not fit into precice_dt, mod(precice_dt, fenics_dt) != 0
-
- # note: the modulo expressions above should be understood in an exact way (no floating point round off problems. For
- # details, see https://stackoverflow.com/questions/14763722/python-modulo-on-floats)
\ No newline at end of file
diff --git a/partitioned-heat-conduction-complex/fenics/precice-adapter-config-D.json b/partitioned-heat-conduction-complex/fenics/precice-adapter-config-D.json
new file mode 100644
index 000000000..9430d6e1e
--- /dev/null
+++ b/partitioned-heat-conduction-complex/fenics/precice-adapter-config-D.json
@@ -0,0 +1,9 @@
+{
+ "participant_name": "Dirichlet",
+ "config_file_name": "../precice-config.xml",
+ "interface": {
+ "coupling_mesh_name": "Dirichlet-Mesh",
+ "write_data_name": "Flux",
+ "read_data_name": "Temperature"
+ }
+}
diff --git a/partitioned-heat-conduction-complex/fenics/precice-adapter-config-N.json b/partitioned-heat-conduction-complex/fenics/precice-adapter-config-N.json
new file mode 100644
index 000000000..b21673b23
--- /dev/null
+++ b/partitioned-heat-conduction-complex/fenics/precice-adapter-config-N.json
@@ -0,0 +1,9 @@
+{
+ "participant_name": "Neumann",
+ "config_file_name": "../precice-config.xml",
+ "interface": {
+ "coupling_mesh_name": "Neumann-Mesh",
+ "write_data_name": "Temperature",
+ "read_data_name": "Flux"
+ }
+}
diff --git a/HT/partitioned-heat/fenics-fenics/problem_setup.py b/partitioned-heat-conduction-complex/fenics/problem_setup.py
similarity index 85%
rename from HT/partitioned-heat/fenics-fenics/problem_setup.py
rename to partitioned-heat-conduction-complex/fenics/problem_setup.py
index fbf9ace6f..a8ddd54cc 100644
--- a/HT/partitioned-heat/fenics-fenics/problem_setup.py
+++ b/partitioned-heat-conduction-complex/fenics/problem_setup.py
@@ -69,30 +69,36 @@ def get_problem_setup(args):
if args.interface == 'simple':
if args.domain == 'circular' or args.domain == 'rectangle':
- raise Exception("Only --domain left or --domain right is supported for --interface {}. Invalid --domain {} provided.".format(args.interface, args.domain))
+ raise Exception("Only --domain left or --domain right is supported for --interface {}. "
+ "Invalid --domain {} provided.".format(args.interface, args.domain))
elif args.domain == 'left':
return DomainPart.LEFT, problem
elif args.domain == 'right':
return DomainPart.RIGHT, problem
elif args.dirichlet and args.neumann:
- raise Exception("you can only choose to either compute the left part of the domain (option -dl) or the right part (option -dr)")
+ raise Exception("You can only choose to either compute the left part of the domain (option -dl) "
+ "or the right part (option -dr)")
elif not (args.domain == 'left' or args.domain == 'right'):
- print("Default domain partitioning for simple interface is used: Left part of domain is a Dirichlet-type problem; right part is a Neumann-type problem")
+ print("Default domain partitioning for simple interface is used: Left part of domain is a "
+ "Dirichlet-type problem; right part is a Neumann-type problem")
if problem is ProblemType.DIRICHLET:
return DomainPart.LEFT, problem
elif problem is ProblemType.NEUMANN:
return DomainPart.RIGHT, problem
elif args.interface == 'complex':
if args.domain == 'left' or args.domain == 'right':
- raise Exception("Only --domain circular or --domain rectangle is supported for --interface {}. Invalid --domain {} provided.".format(args.interface, args.domain))
+ raise Exception("Only --domain circular or --domain rectangle is supported for --interface {}. "
+ "Invalid --domain {} provided.".format(args.interface, args.domain))
elif args.domain == 'circular':
return DomainPart.CIRCULAR, problem
elif args.domain == 'rectangle':
return DomainPart.RECTANGLE, problem
elif args.dirichlet and args.neumann:
- raise Exception("you can only choose to either compute the circular part of the domain (option -dc) or the residual part (option -dnc)")
+ raise Exception("You can only choose to either compute the circular part of the domain (option -dc) "
+ "or the residual part (option -dnc)")
elif not (args.domain == 'circular' or args.domain == 'rectangle'):
- print("Default domain partitioning for complex interface is used: Circular part of domain is a Neumann-type problem; Rest of the domain is a Dirichlet-type problem")
+ print("Default domain partitioning for complex interface is used: Circular part of domain "
+ "is a Neumann-type problem; Rest of the domain is a Dirichlet-type problem")
if problem is ProblemType.NEUMANN:
return DomainPart.CIRCULAR, problem
elif problem is ProblemType.DIRICHLET:
@@ -109,9 +115,9 @@ def get_geometry(domain_part):
n_vertices = 20
if domain_part is DomainPart.LEFT:
- nx = nx*3
+ nx = nx * 3
elif domain_part is DomainPart.RIGHT:
- ny = ny*2
+ ny = ny * 2
elif domain_part is DomainPart.CIRCULAR:
n_vertices = n_vertices
elif domain_part is DomainPart.RECTANGLE:
diff --git a/partitioned-heat-conduction-complex/fenics/run.sh b/partitioned-heat-conduction-complex/fenics/run.sh
new file mode 100755
index 000000000..e31f07a10
--- /dev/null
+++ b/partitioned-heat-conduction-complex/fenics/run.sh
@@ -0,0 +1,16 @@
+#!/bin/sh
+set -e -u
+
+while getopts ":dn" opt; do
+ case ${opt} in
+ d)
+ python3 heat.py -d --error-tol 10e-3
+ ;;
+ n)
+ python3 heat.py -n --error-tol 10e-3
+ ;;
+ \?)
+ echo "Usage: cmd [-d] [-n]"
+ ;;
+ esac
+done
diff --git a/partitioned-heat-conduction-complex/precice-config.xml b/partitioned-heat-conduction-complex/precice-config.xml
new file mode 100644
index 000000000..547a4f207
--- /dev/null
+++ b/partitioned-heat-conduction-complex/precice-config.xml
@@ -0,0 +1,61 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/partitioned-heat-conduction/README.md b/partitioned-heat-conduction/README.md
new file mode 100644
index 000000000..3ee1cf6d0
--- /dev/null
+++ b/partitioned-heat-conduction/README.md
@@ -0,0 +1,77 @@
+---
+title: Partitioned heat conduction
+permalink: tutorials-partitioned-heat-conduction.html
+keywords: FEniCS, Nutils, Heat conduction
+summary: We solve a simple heat equation. The domain is partitioned and the coupling is established in a Dirichlet-Neumann fashion.
+---
+
+## Setup
+
+We solve a partitioned heat equation. For information on the non-partitioned case, please refer to [1, p.37ff]. In this tutorial the computational domain is partitioned and coupled via preCICE. The coupling roughly follows the approach described in [2].
+
+
+
+Case setup from [3]. `D` denotes the Dirichlet participant and `N` denotes the Neumann participant.
+
+The heat equation is solved on a rectangular domain `Omega = [0,2] x [0,1]` with given Dirichlet boundary conditions. We split the domain at `x_c = 1` using a straight vertical line, the coupling interface. The left part of the domain will be referred to as the Dirichlet partition and the right part as the Neumann partition. To couple the two participants we use Dirichlet-Neumann coupling. Here, the Dirichlet participant receives Dirichlet boundary conditions (`Temperature`) at the coupling interface and solves the heat equation using these boundary conditions on the left part of the domain. Then the Dirichlet participant computes the resulting heat flux (`Flux`) from the solution and sends it to the Neumann participant. The Neumann participant uses the flux as a Neumann boundary condition to solve the heat equation on the right part of the domain. We then extract the temperature from the solution and send it back to the Dirichlet participant. This establishes the coupling between the two participants.
+
+This simple case allows us to compare the solution for the partitioned case to a known analytical solution (method of manufactures solutions, see [1, p.37ff]). For more usage examples and details, please refer to [3, sect. 4.1].
+
+## Available solvers and dependencies
+
+You can either couple a solver with itself or different solvers with each other. In any case you will need to have preCICE and the python bindings installed on your system.
+
+* FEniCS. Install [FEniCS](https://fenicsproject.org/download/) and the [FEniCS-adapter](https://github.com/precice/fenics-adapter). The code is largely based on this [fenics-tutorial](https://github.com/hplgit/fenics-tutorial/blob/master/pub/python/vol1/ft03_heat.py) from [1].
+
+* Nutils. Install [Nutils](http://www.nutils.org/en/latest/).
+
+## Running the simulation
+
+This tutorial is for FEniCS and Nutils. You can find the corresponding `run.sh` script in the folders `fenics` and `nutils`.
+
+For choosing whether you want to run the Dirichlet-kind and a Neumann-kind participant, please provide the following commandline input:
+
+* `-d` flag will enforce Dirichlet boundary conditions on the coupling interface.
+* `-n` flag will enforce Neumann boundary conditions on the coupling interface.
+
+For running the case, open two terminals run:
+
+```
+cd fenics
+./run.sh -d
+```
+
+and
+
+```
+cd fenics
+./run.sh -n
+```
+
+If you want to use Nutils for one or both sides of the setup, just `cd nutils`. The FEniCS case also supports parallel runs. Here, you cannot use the `run.sh` script, but must simply execute
+
+```
+mpirun -n heat.py -d
+```
+
+### Note on the combination of Nutils & FEniCS
+
+You can mix the Nutils and FEniCS solver, if you like. Note that the error for a pure FEniCS simulation is lower than for a mixed one. We did not yet study the origin of this error, but assume that this is due to the fact that Nutils uses Gauss points as coupling mesh and therefore entails extrapolation in the data mapping at the top and bottom corners.
+
+## Visualization
+
+Output is written into the folders `fenics/out` and `nutils`.
+
+For FEniCS you can visualize the content with paraview by opening the `*.pvd` files. The files `Dirichlet.pvd` and `Neumann.pvd` correspond to the numerical solution of the Dirichlet, respectively Neumann, problem, while the files with the prefix `ref` correspond to the analytical reference solution, the files with `error` show the error and the files with `ranks` the ranks of the solvers (if executed in parallel).
+
+For Nutils, please use the files `Dirichlet-*.vtk` or `Neumann-*.vtk`. Please note that these files contain the temperature as well as the reference solution.
+
+
+
+Visualization in paraview for `x_c = 1.5`.
+
+## References
+
+[1] Hans Petter Langtangen and Anders Logg. "Solving PDEs in Minutes-The FEniCS Tutorial Volume I." (2016). [pdf](https://fenicsproject.org/pub/tutorial/pdf/fenics-tutorial-vol1.pdf)
+[2] Azahar Monge and Philipp Birken. "Convergence Analysis of the Dirichlet-Neumann Iteration for Finite Element Discretizations." (2016). Proceedings in Applied Mathematics and Mechanics. [doi](https://doi.org/10.1002/pamm.201610355)
+[3] Benjamin Rüth, Benjamin Uekermann, Miriam Mehl, Philipp Birken, Azahar Monge, and Hans Joachim Bungartz. "Quasi-Newton waveform iteration for partitioned surface-coupled multiphysics applications." (2020). International Journal for Numerical Methods in Engineering. [doi](https://doi.org/10.1002/nme.6443)
diff --git a/partitioned-heat-conduction/clean-tutorial.sh b/partitioned-heat-conduction/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/partitioned-heat-conduction/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/partitioned-heat-conduction/fenics/.gitignore b/partitioned-heat-conduction/fenics/.gitignore
new file mode 100644
index 000000000..7c6571e48
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/.gitignore
@@ -0,0 +1,2 @@
+venv
+*.pyc
diff --git a/partitioned-heat-conduction/fenics/clean.sh b/partitioned-heat-conduction/fenics/clean.sh
new file mode 100755
index 000000000..3a8b4619d
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_fenics .
diff --git a/partitioned-heat-conduction/fenics/errorcomputation.py b/partitioned-heat-conduction/fenics/errorcomputation.py
new file mode 100644
index 000000000..2c9ec7367
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/errorcomputation.py
@@ -0,0 +1,15 @@
+from fenics import inner, assemble, dx, project, sqrt
+
+
+def compute_errors(u_approx, u_ref, v, total_error_tol=10 ** -4):
+ # compute pointwise L2 error
+ error_normalized = (u_ref - u_approx) / u_ref
+ # project onto function space
+ error_pointwise = project(abs(error_normalized), v)
+ # determine L2 norm to estimate total error
+ error_total = sqrt(assemble(inner(error_pointwise, error_pointwise) * dx))
+ error_pointwise.rename("error", " ")
+
+ assert (error_total < total_error_tol)
+
+ return error_total, error_pointwise
diff --git a/partitioned-heat-conduction/fenics/heat.py b/partitioned-heat-conduction/fenics/heat.py
new file mode 100644
index 000000000..e7113f570
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/heat.py
@@ -0,0 +1,230 @@
+"""
+The basic example is taken from "Langtangen, Hans Petter, and Anders Logg. Solving PDEs in Python: The FEniCS
+Tutorial I. Springer International Publishing, 2016."
+
+The example code has been extended with preCICE API calls and mixed boundary conditions to allow for a Dirichlet-Neumann
+coupling of two separate heat equations.
+
+The original source code can be found on https://github.com/hplgit/fenics-tutorial/blob/master/pub/python/vol1/ft03_heat.py.
+
+Heat equation with Dirichlet conditions. (Dirichlet problem)
+ u'= Laplace(u) + f in the unit square [0,1] x [0,1]
+ u = u_C on the coupling boundary at x = 1
+ u = u_D on the remaining boundary
+ u = u_0 at t = 0
+ u = 1 + x^2 + alpha*y^2 + \beta*t
+ f = beta - 2 - 2*alpha
+
+Heat equation with mixed boundary conditions. (Neumann problem)
+ u'= Laplace(u) + f in the shifted unit square [1,2] x [0,1]
+ du/dn = f_N on the coupling boundary at x = 1
+ u = u_D on the remaining boundary
+ u = u_0 at t = 0
+ u = 1 + x^2 + alpha*y^2 + \beta*t
+ f = beta - 2 - 2*alpha
+"""
+
+from __future__ import print_function, division
+from fenics import Function, FunctionSpace, Expression, Constant, DirichletBC, TrialFunction, TestFunction, \
+ File, solve, lhs, rhs, grad, inner, dot, dx, ds, interpolate, VectorFunctionSpace, MeshFunction, MPI
+from fenicsprecice import Adapter
+from errorcomputation import compute_errors
+from my_enums import ProblemType, DomainPart
+import argparse
+import numpy as np
+from problem_setup import get_geometry
+import dolfin
+from dolfin import FacetNormal, dot
+
+
+def determine_gradient(V_g, u, flux):
+ """
+ compute flux following http://hplgit.github.io/INF5620/doc/pub/fenics_tutorial1.1/tu2.html#tut-poisson-gradu
+ :param V_g: Vector function space
+ :param u: solution where gradient is to be determined
+ :param flux: returns calculated flux into this value
+ """
+
+ w = TrialFunction(V_g)
+ v = TestFunction(V_g)
+
+ a = inner(w, v) * dx
+ L = inner(grad(u), v) * dx
+ solve(a == L, flux)
+
+
+parser = argparse.ArgumentParser(description="Solving heat equation for simple or complex interface case")
+command_group = parser.add_mutually_exclusive_group(required=True)
+command_group.add_argument("-d", "--dirichlet", help="create a dirichlet problem", dest="dirichlet",
+ action="store_true")
+command_group.add_argument("-n", "--neumann", help="create a neumann problem", dest="neumann", action="store_true")
+parser.add_argument("-e", "--error-tol", help="set error tolerance", type=float, default=10**-6,)
+
+args = parser.parse_args()
+
+fenics_dt = .1 # time step size
+# Error is bounded by coupling accuracy. In theory we would obtain the analytical solution.
+error_tol = args.error_tol
+
+alpha = 3 # parameter alpha
+beta = 1.3 # parameter beta
+
+if args.dirichlet and not args.neumann:
+ problem = ProblemType.DIRICHLET
+ domain_part = DomainPart.LEFT
+elif args.neumann and not args.dirichlet:
+ problem = ProblemType.NEUMANN
+ domain_part = DomainPart.RIGHT
+
+mesh, coupling_boundary, remaining_boundary = get_geometry(domain_part)
+
+# Define function space using mesh
+V = FunctionSpace(mesh, 'P', 2)
+V_g = VectorFunctionSpace(mesh, 'P', 1)
+W = V_g.sub(0).collapse()
+
+# Define boundary conditions
+u_D = Expression('1 + x[0]*x[0] + alpha*x[1]*x[1] + beta*t', degree=2, alpha=alpha, beta=beta, t=0)
+u_D_function = interpolate(u_D, V)
+
+if problem is ProblemType.DIRICHLET:
+ # Define flux in x direction
+ f_N = Expression("2 * x[0]", degree=1, alpha=alpha, t=0)
+ f_N_function = interpolate(f_N, W)
+
+# Define initial value
+u_n = interpolate(u_D, V)
+u_n.rename("Temperature", "")
+
+precice, precice_dt, initial_data = None, 0.0, None
+
+# Initialize the adapter according to the specific participant
+if problem is ProblemType.DIRICHLET:
+ precice = Adapter(adapter_config_filename="precice-adapter-config-D.json")
+ precice_dt = precice.initialize(coupling_boundary, read_function_space=V, write_object=f_N_function)
+elif problem is ProblemType.NEUMANN:
+ precice = Adapter(adapter_config_filename="precice-adapter-config-N.json")
+ precice_dt = precice.initialize(coupling_boundary, read_function_space=W, write_object=u_D_function)
+
+dt = Constant(0)
+dt.assign(np.min([fenics_dt, precice_dt]))
+
+# Define variational problem
+u = TrialFunction(V)
+v = TestFunction(V)
+f = Expression('beta - 2 - 2*alpha', degree=2, alpha=alpha, beta=beta, t=0)
+F = u * v / dt * dx + dot(grad(u), grad(v)) * dx - (u_n / dt + f) * v * dx
+
+bcs = [DirichletBC(V, u_D, remaining_boundary)]
+
+# Set boundary conditions at coupling interface once wrt to the coupling
+# expression
+coupling_expression = precice.create_coupling_expression()
+if problem is ProblemType.DIRICHLET:
+ # modify Dirichlet boundary condition on coupling interface
+ bcs.append(DirichletBC(V, coupling_expression, coupling_boundary))
+if problem is ProblemType.NEUMANN:
+ # modify Neumann boundary condition on coupling interface, modify weak
+ # form correspondingly
+ F += v * coupling_expression * dolfin.ds
+
+a, L = lhs(F), rhs(F)
+
+# Time-stepping
+u_np1 = Function(V)
+u_np1.rename("Temperature", "")
+t = 0
+
+# reference solution at t=0
+u_ref = interpolate(u_D, V)
+u_ref.rename("reference", " ")
+
+# mark mesh w.r.t ranks
+mesh_rank = MeshFunction("size_t", mesh, mesh.topology().dim())
+if problem is ProblemType.NEUMANN:
+ mesh_rank.set_all(MPI.rank(MPI.comm_world) + 4)
+else:
+ mesh_rank.set_all(MPI.rank(MPI.comm_world) + 0)
+mesh_rank.rename("myRank", "")
+
+# Generating output files
+temperature_out = File("out/%s.pvd" % precice.get_participant_name())
+ref_out = File("out/ref%s.pvd" % precice.get_participant_name())
+error_out = File("out/error%s.pvd" % precice.get_participant_name())
+ranks = File("out/ranks%s.pvd" % precice.get_participant_name())
+
+# output solution and reference solution at t=0, n=0
+n = 0
+print('output u^%d and u_ref^%d' % (n, n))
+temperature_out << u_n
+ref_out << u_ref
+ranks << mesh_rank
+
+error_total, error_pointwise = compute_errors(u_n, u_ref, V)
+error_out << error_pointwise
+
+# set t_1 = t_0 + dt, this gives u_D^1
+# call dt(0) to evaluate FEniCS Constant. Todo: is there a better way?
+u_D.t = t + dt(0)
+f.t = t + dt(0)
+
+if problem is ProblemType.DIRICHLET:
+ flux = Function(V_g)
+ flux.rename("Flux", "")
+
+while precice.is_coupling_ongoing():
+
+ # write checkpoint
+ if precice.is_action_required(precice.action_write_iteration_checkpoint()):
+ precice.store_checkpoint(u_n, t, n)
+
+ read_data = precice.read_data()
+
+ # Update the coupling expression with the new read data
+ precice.update_coupling_expression(coupling_expression, read_data)
+
+ dt.assign(np.min([fenics_dt, precice_dt]))
+
+ # Compute solution u^n+1, use bcs u_D^n+1, u^n and coupling bcs
+ solve(a == L, u_np1, bcs)
+
+ # Write data to preCICE according to which problem is being solved
+ if problem is ProblemType.DIRICHLET:
+ # Dirichlet problem reads temperature and writes flux on boundary to Neumann problem
+ determine_gradient(V_g, u_np1, flux)
+ flux_x = interpolate(flux.sub(0), W)
+ precice.write_data(flux_x)
+ elif problem is ProblemType.NEUMANN:
+ # Neumann problem reads flux and writes temperature on boundary to Dirichlet problem
+ precice.write_data(u_np1)
+
+ precice_dt = precice.advance(dt(0))
+
+ # roll back to checkpoint
+ if precice.is_action_required(precice.action_read_iteration_checkpoint()):
+ u_cp, t_cp, n_cp = precice.retrieve_checkpoint()
+ u_n.assign(u_cp)
+ t = t_cp
+ n = n_cp
+ else: # update solution
+ u_n.assign(u_np1)
+ t += float(dt)
+ n += 1
+
+ if precice.is_time_window_complete():
+ u_ref = interpolate(u_D, V)
+ u_ref.rename("reference", " ")
+ error, error_pointwise = compute_errors(u_n, u_ref, V, total_error_tol=error_tol)
+ print('n = %d, t = %.2f: L2 error on domain = %.3g' % (n, t, error))
+ # output solution and reference solution at t_n+1
+ print('output u^%d and u_ref^%d' % (n, n))
+ temperature_out << u_n
+ ref_out << u_ref
+ error_out << error_pointwise
+
+ # Update Dirichlet BC
+ u_D.t = t + float(dt)
+ f.t = t + float(dt)
+
+# Hold plot
+precice.finalize()
diff --git a/partitioned-heat-conduction/fenics/my_enums.py b/partitioned-heat-conduction/fenics/my_enums.py
new file mode 100644
index 000000000..27fc5d9ae
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/my_enums.py
@@ -0,0 +1,19 @@
+from enum import Enum
+
+
+class ProblemType(Enum):
+ """
+ Enum defines problem type. Details see above.
+ """
+ DIRICHLET = 1 # Dirichlet problem
+ NEUMANN = 2 # Neumann problem
+
+
+class DomainPart(Enum):
+ """
+ Enum defines which part of the domain [x_left, x_right] x [y_bottom, y_top] we compute.
+ """
+ LEFT = 1 # left part of domain in simple interface case
+ RIGHT = 2 # right part of domain in simple interface case
+ CIRCULAR = 3 # circular part of domain in complex interface case
+ RECTANGLE = 4 # domain excluding circular part of complex interface case
diff --git a/partitioned-heat-conduction/fenics/precice-adapter-config-D.json b/partitioned-heat-conduction/fenics/precice-adapter-config-D.json
new file mode 100644
index 000000000..c2a7788c0
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/precice-adapter-config-D.json
@@ -0,0 +1,9 @@
+{
+ "participant_name": "Dirichlet",
+ "config_file_name": "../precice-config.xml",
+ "interface": {
+ "coupling_mesh_name": "Dirichlet-Mesh",
+ "write_data_name": "Flux",
+ "read_data_name": "Temperature"
+ }
+}
diff --git a/partitioned-heat-conduction/fenics/precice-adapter-config-N.json b/partitioned-heat-conduction/fenics/precice-adapter-config-N.json
new file mode 100644
index 000000000..36ea15d19
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/precice-adapter-config-N.json
@@ -0,0 +1,9 @@
+{
+ "participant_name": "Neumann",
+ "config_file_name": "../precice-config.xml",
+ "interface": {
+ "coupling_mesh_name": "Neumann-Mesh",
+ "write_data_name": "Temperature",
+ "read_data_name": "Flux"
+ }
+}
diff --git a/partitioned-heat-conduction/fenics/problem_setup.py b/partitioned-heat-conduction/fenics/problem_setup.py
new file mode 100644
index 000000000..cb1b164af
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/problem_setup.py
@@ -0,0 +1,56 @@
+"""
+Problem setup for partitioned-heat-conduction/fenics-fenics tutorial
+"""
+
+from fenics import SubDomain, Point, RectangleMesh, near, Function, VectorFunctionSpace, Expression
+from my_enums import DomainPart
+
+
+y_bottom, y_top = 0, 1
+x_left, x_right = 0, 2
+x_coupling = 1.0 # x coordinate of coupling interface
+radius = 0.2
+midpoint = Point(0.5, 0.5)
+
+
+class ExcludeStraightBoundary(SubDomain):
+ def get_user_input_args(self, args):
+ self._interface = args.interface
+
+ def inside(self, x, on_boundary):
+ tol = 1E-14
+ if on_boundary and not near(x[0], x_coupling, tol) or near(x[1], y_top, tol) or near(x[1], y_bottom, tol):
+ return True
+ else:
+ return False
+
+
+class StraightBoundary(SubDomain):
+ def inside(self, x, on_boundary):
+ tol = 1E-14
+ if on_boundary and near(x[0], x_coupling, tol):
+ return True
+ else:
+ return False
+
+
+def get_geometry(domain_part):
+ nx = ny = 9
+ low_resolution = 5
+ high_resolution = 5
+ n_vertices = 20
+
+ if domain_part is DomainPart.LEFT:
+ p0 = Point(x_left, y_bottom)
+ p1 = Point(x_coupling, y_top)
+ elif domain_part is DomainPart.RIGHT:
+ p0 = Point(x_coupling, y_bottom)
+ p1 = Point(x_right, y_top)
+ else:
+ raise Exception("invalid domain_part: {}".format(domain_part))
+
+ mesh = RectangleMesh(p0, p1, nx, ny, diagonal="left")
+ coupling_boundary = StraightBoundary()
+ remaining_boundary = ExcludeStraightBoundary()
+
+ return mesh, coupling_boundary, remaining_boundary
diff --git a/partitioned-heat-conduction/fenics/run.sh b/partitioned-heat-conduction/fenics/run.sh
new file mode 100755
index 000000000..e31f07a10
--- /dev/null
+++ b/partitioned-heat-conduction/fenics/run.sh
@@ -0,0 +1,16 @@
+#!/bin/sh
+set -e -u
+
+while getopts ":dn" opt; do
+ case ${opt} in
+ d)
+ python3 heat.py -d --error-tol 10e-3
+ ;;
+ n)
+ python3 heat.py -n --error-tol 10e-3
+ ;;
+ \?)
+ echo "Usage: cmd [-d] [-n]"
+ ;;
+ esac
+done
diff --git a/partitioned-heat-conduction/images/tutorials-partitioned-heat-conduction-FEniCS-movie.gif b/partitioned-heat-conduction/images/tutorials-partitioned-heat-conduction-FEniCS-movie.gif
new file mode 100644
index 000000000..8726ae151
Binary files /dev/null and b/partitioned-heat-conduction/images/tutorials-partitioned-heat-conduction-FEniCS-movie.gif differ
diff --git a/partitioned-heat-conduction/images/tutorials-partitioned-heat-conduction-setup.png b/partitioned-heat-conduction/images/tutorials-partitioned-heat-conduction-setup.png
new file mode 100644
index 000000000..b494c6a70
Binary files /dev/null and b/partitioned-heat-conduction/images/tutorials-partitioned-heat-conduction-setup.png differ
diff --git a/partitioned-heat-conduction/nutils/.gitignore b/partitioned-heat-conduction/nutils/.gitignore
new file mode 100644
index 000000000..53639607d
--- /dev/null
+++ b/partitioned-heat-conduction/nutils/.gitignore
@@ -0,0 +1,4 @@
+Neumann-*.vtk
+Dirichlet-*.vtk
+*.log
+precice-*-events.json
diff --git a/partitioned-heat-conduction/nutils/clean.sh b/partitioned-heat-conduction/nutils/clean.sh
new file mode 100755
index 000000000..6684cc729
--- /dev/null
+++ b/partitioned-heat-conduction/nutils/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_nutils
diff --git a/partitioned-heat-conduction/nutils/heat.py b/partitioned-heat-conduction/nutils/heat.py
new file mode 100644
index 000000000..16c00726e
--- /dev/null
+++ b/partitioned-heat-conduction/nutils/heat.py
@@ -0,0 +1,175 @@
+#! /usr/bin/env python3
+
+import nutils
+import treelog
+import numpy as np
+import precice
+
+
+def main(side='Dirichlet'):
+
+ print("Running nutils")
+
+ # domain size
+ y_bottom, y_top = 0, 1
+ x_left, x_right = 0, 2
+ x_coupling = 1 # x coordinate of coupling interface
+
+ n = 10 # number of mesh vertices per dimension
+
+ if side == 'Dirichlet':
+ x_grid = np.linspace(x_left, x_coupling, n)
+ elif side == 'Neumann':
+ x_grid = np.linspace(x_coupling, x_right, n)
+ else:
+ raise Exception('invalid side {!r}'.format(side))
+
+ y_grid = np.linspace(y_bottom, y_top, n)
+
+ # define the Nutils mesh
+ domain, geom = nutils.mesh.rectilinear([x_grid, y_grid])
+
+ # Nutils namespace
+ ns = nutils.function.Namespace()
+ ns.x = geom
+
+ degree = 1 # linear finite elements
+ ns.basis = domain.basis('std', degree=degree)
+ ns.alpha = 3 # parameter of problem
+ ns.beta = 1.3 # parameter of problem
+ ns.u = 'basis_n ?lhs_n' # solution
+ ns.dudt = 'basis_n (?lhs_n - ?lhs0_n) / ?dt' # time derivative
+ ns.flux = 'basis_n ?fluxdofs_n' # heat flux
+ ns.f = 'beta - 2 - 2 alpha' # rhs
+ ns.uexact = '1 + x_0 x_0 + alpha x_1 x_1 + beta ?t' # analytical solution
+
+ # define the weak form
+ res0 = domain.integral('(basis_n dudt - basis_n f + basis_n,i u_,i) d:x' @ ns, degree=degree * 2)
+
+ # set boundary conditions at non-coupling boundaries
+ # top and bottom boundary are non-coupling for both sides
+ sqr0 = domain.boundary['top'].integral('(u - 1 - x_0 x_0 - alpha - beta ?t)^2 d:x' @ ns, degree=degree * 2)
+ sqr0 += domain.boundary['bottom'].integral('(u - 1 - x_0 x_0 - beta ?t)^2 d:x' @ ns, degree=degree * 2)
+ if side == 'Dirichlet': # left boundary is non-coupling
+ sqr0 += domain.boundary['left'].integral('(u - 1 - alpha x_1 x_1 - beta ?t)^2 d:x' @ ns, degree=degree * 2)
+ elif side == 'Neumann': # right boundary is non-coupling
+ sqr0 += domain.boundary['right'].integral('(u - 1 - x_0 x_0 - alpha x_1 x_1 - beta ?t)^2 d:x' @ ns,
+ degree=degree * 2)
+
+ # preCICE setup
+ interface = precice.Interface(side, "../precice-config.xml", 0, 1)
+
+ # define coupling mesh
+ mesh_name = side + "-Mesh"
+ mesh_id = interface.get_mesh_id(mesh_name)
+ coupling_boundary = domain.boundary['right' if side == 'Dirichlet' else 'left']
+ coupling_sample = coupling_boundary.sample('gauss', degree=degree * 2)
+ vertices = coupling_sample.eval(ns.x)
+ vertex_ids = interface.set_mesh_vertices(mesh_id, vertices)
+
+ # coupling data
+ write_data = "Temperature" if side == "Neumann" else "Flux"
+ read_data = "Flux" if side == "Neumann" else "Temperature"
+ write_data_id = interface.get_data_id(write_data, mesh_id)
+ read_data_id = interface.get_data_id(read_data, mesh_id)
+
+ # helper functions to project heat flux to coupling boundary
+ projection_matrix = coupling_boundary.integrate(ns.eval_nm('basis_n basis_m d:x'), degree=degree * 2)
+ projection_cons = np.zeros(res0.shape)
+ projection_cons[projection_matrix.rowsupp(1e-15)] = np.nan
+ def fluxdofs(v): return projection_matrix.solve(v, constrain=projection_cons)
+
+ # helper data structure to apply heat flux correctly
+ dx_function = 'd:x' @ ns
+
+ precice_dt = interface.initialize()
+
+ # write initial data
+ if interface.is_action_required(precice.action_write_initial_data()):
+ write_data = np.zeros(len(vertex_ids))
+ interface.write_block_scalar_data(write_data_id, vertex_ids, write_data)
+ interface.mark_action_fulfilled(precice.action_write_initial_data())
+
+ interface.initialize_data()
+
+ t = 0
+
+ # initial condition
+ sqr = domain.integral('(u - uexact)^2' @ ns, degree=degree * 2)
+ lhs0 = nutils.solver.optimize('lhs', sqr, droptol=1e-15, arguments=dict(t=t))
+ bezier = domain.sample('bezier', degree * 2)
+ x, u, uexact = bezier.eval(['x_i', 'u', 'uexact'] @ ns, lhs=lhs0, t=t)
+ with treelog.add(treelog.DataLog()):
+ nutils.export.vtk(side + '-0', bezier.tri, x, Temperature=u, reference=uexact)
+
+ t += precice_dt
+ timestep = 0
+ dt = 0.1
+
+ while interface.is_coupling_ongoing():
+
+ # update (time-dependent) boundary condition
+ cons0 = nutils.solver.optimize('lhs', sqr0, droptol=1e-15, arguments=dict(t=t))
+
+ # read data from interface
+ if interface.is_read_data_available():
+ read_data = interface.read_block_scalar_data(read_data_id, vertex_ids)
+ read_function = coupling_sample.asfunction(read_data)
+
+ if side == 'Dirichlet':
+ sqr = coupling_sample.integral((ns.u - read_function)**2)
+ cons = nutils.solver.optimize('lhs', sqr, droptol=1e-15, constrain=cons0, arguments=dict(t=t))
+ res = res0
+ else:
+ cons = cons0
+ res = res0 + coupling_sample.integral(ns.basis * read_function * dx_function)
+
+ # save checkpoint
+ if interface.is_action_required(precice.action_write_iteration_checkpoint()):
+ lhs_checkpoint = lhs0
+ t_checkpoint = t
+ timestep_checkpoint = timestep
+ interface.mark_action_fulfilled(precice.action_write_iteration_checkpoint())
+
+ # potentially adjust non-matching timestep sizes
+ dt = min(dt, precice_dt)
+
+ # solve nutils timestep
+ lhs = nutils.solver.solve_linear('lhs', res, constrain=cons, arguments=dict(lhs0=lhs0, dt=dt, t=t))
+
+ # write data to interface
+ if interface.is_write_data_required(dt):
+ if side == 'Dirichlet':
+ flux_function = res.eval(lhs0=lhs0, lhs=lhs, dt=dt, t=t)
+ write_data = coupling_sample.eval('flux' @ ns, fluxdofs=fluxdofs(flux_function))
+ else:
+ write_data = coupling_sample.eval('u' @ ns, lhs=lhs)
+
+ interface.write_block_scalar_data(write_data_id, vertex_ids, write_data)
+
+ # do the coupling
+ precice_dt = interface.advance(dt)
+
+ # advance variables
+ t += dt
+ timestep += 1
+ lhs0 = lhs
+
+ # read checkpoint if required
+ if interface.is_action_required(precice.action_read_iteration_checkpoint()):
+ lhs0 = lhs_checkpoint
+ t = t_checkpoint
+ timestep = timestep_checkpoint
+ interface.mark_action_fulfilled(precice.action_read_iteration_checkpoint())
+ else: # go to next timestep
+ bezier = domain.sample('bezier', degree * 2)
+ x, u, uexact = bezier.eval(['x_i', 'u', 'uexact'] @ ns, lhs=lhs, t=t)
+
+ with treelog.add(treelog.DataLog()):
+ nutils.export.vtk(side + "-" + str(timestep), bezier.tri, x, Temperature=u, reference=uexact)
+
+ interface.finalize()
+
+
+if __name__ == '__main__':
+ nutils.cli.run(main)
diff --git a/partitioned-heat-conduction/nutils/run.sh b/partitioned-heat-conduction/nutils/run.sh
new file mode 100755
index 000000000..43e97b70f
--- /dev/null
+++ b/partitioned-heat-conduction/nutils/run.sh
@@ -0,0 +1,18 @@
+#!/bin/sh
+set -e -u
+
+while getopts ":dn" opt; do
+ case ${opt} in
+ d)
+ rm -rf Dirichlet-*.vtk
+ python3 heat.py --side=Dirichlet
+ ;;
+ n)
+ rm -rf Neumann-*.vtk
+ python3 heat.py --side=Neumann
+ ;;
+ \?)
+ echo "Usage: cmd [-d] [-n]"
+ ;;
+ esac
+done
diff --git a/partitioned-heat-conduction/precice-config.xml b/partitioned-heat-conduction/precice-config.xml
new file mode 100644
index 000000000..a810f285d
--- /dev/null
+++ b/partitioned-heat-conduction/precice-config.xml
@@ -0,0 +1,61 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/partitioned-pipe/README.md b/partitioned-pipe/README.md
new file mode 100644
index 000000000..f29413dff
--- /dev/null
+++ b/partitioned-pipe/README.md
@@ -0,0 +1,49 @@
+---
+title: Partitioned pipe flow
+permalink: tutorials-partitioned-pipe.html
+keywords: tutorial, FF, fluid-fluid coupling, OpenFOAM, pimpleFoam, sonicLiquidFoam
+summary: This tutorial describes how to run a partitioned fluid simulation using preCICE.
+---
+
+## Setup
+
+This scenario consists of two pipes connected in series. A fluid enters from the left (here $$ z=0 $$) boundary of the Fluid1 participant with a uniform velocity profile ($$ u_{in} = 0.1 m/s $$) and zero pressure gradient. In its starting, uncoupled state, it exits from the right side (outlet: zero velocity gradient, zero pressure). This is also the coupling interface with Fluid2, which has the same boundary conditions as Fluid1.
+
+On the coupling interface, Fluid1 sends velocity and pressure gradient to Fluid2 and receives pressure. The additional pressure gradient exchange was found to help convergence [1], but this fluid-fluid coupling scenario is part of active research.
+
+## Available solvers
+
+Both for Fluid1 and Fluid2, the following participants are available:
+
+* OpenFOAM (pimpleFoam). An incompressible OpenFOAM solver. For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+* OpenFOAM (sonicLiquidFoam). A compressible OpenFOAM solver. For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+## Running the Simulation
+
+All listed solvers can be used in order to run the simulation. Open two separate terminals and start the desired fluid1 and fluid2 participants by calling the respective run script. For example:
+
+```
+cd fluid1-openfoam-pimplefoam
+./run.sh
+```
+and
+```
+cd fluid2-openfoam-sonicliquidfoam
+./run.sh
+```
+
+## Post-processing
+
+The OpenFOAM solvers generate a `.foam` file each. You can open this file in ParaView.
+An example of the visualized expected results looks as follows:
+
+
+
+Observe that the velocity and pressure values are smoothly changing around the coupling interface. The simulation starts with oscillations, which disappear after a few time steps.
+
+## References
+
+[1] G. Chourdakis, B. Uekermann, G. V. Zwieten, and H. V. Brummelen: [Coupling OpenFOAM to different solvers, physics, models, and dimensions using preCICE](https://mediatum.ub.tum.de/1515271), 14th OpenFOAM Workshop, Duisburg, Germany, submitted (proceedings publication delayed/cancelled), July 2019.
+
+{% include disclaimer.html content="This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks." %}
diff --git a/partitioned-pipe/clean-tutorial.sh b/partitioned-pipe/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/partitioned-pipe/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/0/U b/partitioned-pipe/fluid1-openfoam-pimplefoam/0/U
new file mode 100644
index 000000000..fd165fe4e
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/0/U
@@ -0,0 +1,30 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volVectorField;
+ location "0";
+ object U;
+}
+
+dimensions [0 1 -1 0 0 0 0];
+
+internalField uniform (0 0 0.1);
+
+boundaryField
+{
+ inlet
+ {
+ type fixedValue;
+ value $internalField;
+ }
+ outlet
+ {
+ type fixedGradient;
+ gradient uniform (0 0 0);
+ }
+ fixedWalls
+ {
+ type noSlip;
+ }
+}
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/0/p b/partitioned-pipe/fluid1-openfoam-pimplefoam/0/p
new file mode 100644
index 000000000..ada3a6d88
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/0/p
@@ -0,0 +1,31 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ object p;
+}
+
+dimensions [0 2 -2 0 0 0 0];
+
+internalField uniform 0;
+
+boundaryField
+{
+ inlet
+ {
+ type fixedGradient;
+ gradient uniform 0;
+ }
+
+ outlet
+ {
+ type fixedValue;
+ value uniform 0;
+ }
+
+ fixedWalls
+ {
+ type zeroGradient;
+ }
+}
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/clean.sh b/partitioned-pipe/fluid1-openfoam-pimplefoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/constant/transportProperties b/partitioned-pipe/fluid1-openfoam-pimplefoam/constant/transportProperties
new file mode 100644
index 000000000..c055a4bfa
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/constant/transportProperties
@@ -0,0 +1,12 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object transportProperties;
+}
+
+transportModel Newtonian;
+
+nu nu [ 0 2 -1 0 0 0 0 ] 1e1;
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/constant/turbulenceProperties b/partitioned-pipe/fluid1-openfoam-pimplefoam/constant/turbulenceProperties
new file mode 100644
index 000000000..2c55a8b28
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/constant/turbulenceProperties
@@ -0,0 +1,10 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object turbulenceProperties;
+}
+
+simulationType laminar;
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/run.sh b/partitioned-pipe/fluid1-openfoam-pimplefoam/run.sh
new file mode 100755
index 000000000..7cadd6f3a
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid1-openfoam-pimplefoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/system/blockMeshDict b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/blockMeshDict
new file mode 100644
index 000000000..a2b080b83
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/blockMeshDict
@@ -0,0 +1,104 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant/polyMesh";
+ object blockMeshDict;
+}
+
+convertToMeters 1;
+
+
+zmin 0;
+zmax 20;
+
+xcells 10; // per block (5 blocks)
+ycells 10; // per block (5 blocks)
+zcells 20;
+
+vertices
+(
+ (-3.535534 -3.535534 $zmin) // 0
+ ( 3.535534 -3.535534 $zmin) // 1
+ ( 3.535534 3.535534 $zmin) // 2
+ (-3.535534 3.535534 $zmin) // 3
+ (-1.414214 -1.414214 $zmin) // 4
+ ( 1.414214 -1.414214 $zmin) // 5
+ ( 1.414214 1.414214 $zmin) // 6
+ (-1.414214 1.414214 $zmin) // 7
+
+ (-3.535534 -3.535534 $zmax) // 8
+ ( 3.535534 -3.535534 $zmax) // 9
+ ( 3.535534 3.535534 $zmax) // 10
+ (-3.535534 3.535534 $zmax) // 11
+ (-1.414214 -1.414214 $zmax) // 12
+ ( 1.414214 -1.414214 $zmax) // 13
+ ( 1.414214 1.414214 $zmax) // 14
+ (-1.414214 1.414214 $zmax) // 15
+);
+
+blocks
+(
+hex (0 1 5 4 8 9 13 12) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (1 2 6 5 9 10 14 13) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (2 3 7 6 10 11 15 14) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (3 0 4 7 11 8 12 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (4 5 6 7 12 13 14 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+);
+
+edges
+(
+arc 0 1 ( 0 -5 $zmin)
+arc 1 2 ( 5 0 $zmin)
+arc 2 3 ( 0 5 $zmin)
+arc 3 0 (-5 0 $zmin)
+arc 4 5 ( 0 -1.5 $zmin)
+arc 5 6 ( 1.5 0 $zmin)
+arc 6 7 ( 0 1.5 $zmin)
+arc 7 4 (-1.5 0 $zmin)
+
+arc 8 9 ( 0 -5 $zmax)
+arc 9 10 ( 5 0 $zmax)
+arc 10 11 ( 0 5 $zmax)
+arc 11 8 (-5 0 $zmax)
+arc 12 13 ( 0 -1.5 $zmax)
+arc 13 14 (1.5 0 $zmax)
+arc 14 15 ( 0 1.5 $zmax)
+arc 15 12 (-1.5 0 $zmax)
+);
+
+
+patches
+(
+
+ patch fixedWalls
+ (
+ (0 1 9 8)
+ (1 2 10 9)
+ (2 3 11 10)
+ (3 0 8 11)
+ )
+
+ patch inlet
+ (
+ (0 1 5 4)
+ (1 2 6 5)
+ (2 3 7 6)
+ (3 0 4 7)
+ (4 5 6 7)
+ )
+
+ patch outlet
+ (
+ (8 9 13 12)
+ (9 10 14 13)
+ (10 11 15 14)
+ (12 13 14 15)
+ (11 8 12 15)
+ )
+);
+
+mergePatchPairs
+(
+);
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/system/controlDict b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/controlDict
new file mode 100644
index 000000000..9fe0ab9f5
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/controlDict
@@ -0,0 +1,45 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object controlDict;
+}
+
+application pimpleFoam;
+
+startFrom startTime;
+
+startTime 0;
+
+stopAt endTime;
+
+endTime 10.0;
+
+deltaT 0.01;
+
+writeControl adjustableRunTime;
+
+writeInterval 0.01;
+
+purgeWrite 0;
+
+writeFormat ascii;
+
+writePrecision 6;
+
+writeCompression off;
+
+timeFormat general;
+
+timePrecision 6;
+
+functions
+{
+ preCICE_Adapter
+ {
+ type preciceAdapterFunctionObject;
+ libs ("libpreciceAdapterFunctionObject.so");
+ }
+}
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/system/decomposeParDict b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/decomposeParDict
new file mode 100644
index 000000000..ad99cf6c5
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/decomposeParDict
@@ -0,0 +1,16 @@
+FoamFile {
+ version 2.0;
+ class dictionary;
+ object decomposeParDict;
+ format ascii;
+}
+
+numberOfSubdomains 2;
+
+method simple;
+
+simpleCoeffs
+{
+ n (2 1 1);
+ delta 0.001;
+}
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/fvSchemes b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/fvSchemes
similarity index 76%
rename from FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/fvSchemes
rename to partitioned-pipe/fluid1-openfoam-pimplefoam/system/fvSchemes
index 812dea539..a22010ae4 100644
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/fvSchemes
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/fvSchemes
@@ -6,7 +6,6 @@ FoamFile
location "system";
object fvSchemes;
}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
ddtSchemes
{
@@ -39,6 +38,3 @@ snGradSchemes
{
default corrected;
}
-
-
-// ************************************************************************* //
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/fvSolution b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/fvSolution
similarity index 82%
rename from FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/fvSolution
rename to partitioned-pipe/fluid1-openfoam-pimplefoam/system/fvSolution
index 134915d5f..7e4fe2724 100644
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/system/fvSolution
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/fvSolution
@@ -6,7 +6,6 @@ FoamFile
location "system";
object fvSolution;
}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
solvers
{
@@ -62,8 +61,6 @@ PIMPLE
{
nCorrectors 4;
nNonOrthogonalCorrectors 1;
- // tolerance 1.0e-14;
- // relTol 5e-3;
consistent true;
correctPhi true;
momentumPredictor true;
@@ -75,7 +72,3 @@ potentialFlow
{
nNonOrthogonalCorrectors 10;
}
-
-
-
-// ************************************************************************* //
diff --git a/partitioned-pipe/fluid1-openfoam-pimplefoam/system/preciceDict b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/preciceDict
new file mode 100644
index 000000000..b496662d1
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-pimplefoam/system/preciceDict
@@ -0,0 +1,34 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object preciceDict;
+}
+
+preciceConfig "../precice-config.xml";
+
+participant Fluid1;
+
+modules (FF);
+
+interfaces
+{
+ Interface1
+ {
+ mesh Fluid1-Mesh;
+ patches (outlet);
+
+ readData
+ (
+ Pressure
+ );
+
+ writeData
+ (
+ Velocity
+ PressureGradient
+ );
+ };
+};
\ No newline at end of file
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/0/U b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/0/U
new file mode 100644
index 000000000..fd165fe4e
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/0/U
@@ -0,0 +1,30 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volVectorField;
+ location "0";
+ object U;
+}
+
+dimensions [0 1 -1 0 0 0 0];
+
+internalField uniform (0 0 0.1);
+
+boundaryField
+{
+ inlet
+ {
+ type fixedValue;
+ value $internalField;
+ }
+ outlet
+ {
+ type fixedGradient;
+ gradient uniform (0 0 0);
+ }
+ fixedWalls
+ {
+ type noSlip;
+ }
+}
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/0/p b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/0/p
new file mode 100644
index 000000000..eefaf12bd
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/0/p
@@ -0,0 +1,31 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ object p;
+}
+
+dimensions [1 -1 -2 0 0 0 0];
+
+internalField uniform 0;
+
+boundaryField
+{
+ inlet
+ {
+ type fixedGradient;
+ gradient uniform 0;
+ }
+
+ outlet
+ {
+ type fixedValue;
+ value uniform 0;
+ }
+
+ fixedWalls
+ {
+ type zeroGradient;
+ }
+}
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/clean.sh b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/thermodynamicProperties b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/thermodynamicProperties
new file mode 100644
index 000000000..6bc1693b3
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/thermodynamicProperties
@@ -0,0 +1,14 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object thermodynamicProperties;
+}
+
+rho0 rho0 [1 -3 0 0 0 0 0] 1;
+
+p0 p0 [1 -1 -2 0 0 0 0] 100000;
+
+psi psi [0 -2 2 0 0 0 0] 4.54e-07;
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/transportProperties b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/transportProperties
new file mode 100644
index 000000000..0f39f4183
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/transportProperties
@@ -0,0 +1,10 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object transportProperties;
+}
+
+mu mu [1 -1 -1 0 0 0 0] 1e1;
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/turbulenceProperties b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/turbulenceProperties
new file mode 100644
index 000000000..2c55a8b28
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/constant/turbulenceProperties
@@ -0,0 +1,10 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object turbulenceProperties;
+}
+
+simulationType laminar;
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/run.sh b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/run.sh
new file mode 100755
index 000000000..76e94cbc8
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid1-openfoam-sonicliquidfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/blockMeshDict b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/blockMeshDict
new file mode 100644
index 000000000..a2b080b83
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/blockMeshDict
@@ -0,0 +1,104 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant/polyMesh";
+ object blockMeshDict;
+}
+
+convertToMeters 1;
+
+
+zmin 0;
+zmax 20;
+
+xcells 10; // per block (5 blocks)
+ycells 10; // per block (5 blocks)
+zcells 20;
+
+vertices
+(
+ (-3.535534 -3.535534 $zmin) // 0
+ ( 3.535534 -3.535534 $zmin) // 1
+ ( 3.535534 3.535534 $zmin) // 2
+ (-3.535534 3.535534 $zmin) // 3
+ (-1.414214 -1.414214 $zmin) // 4
+ ( 1.414214 -1.414214 $zmin) // 5
+ ( 1.414214 1.414214 $zmin) // 6
+ (-1.414214 1.414214 $zmin) // 7
+
+ (-3.535534 -3.535534 $zmax) // 8
+ ( 3.535534 -3.535534 $zmax) // 9
+ ( 3.535534 3.535534 $zmax) // 10
+ (-3.535534 3.535534 $zmax) // 11
+ (-1.414214 -1.414214 $zmax) // 12
+ ( 1.414214 -1.414214 $zmax) // 13
+ ( 1.414214 1.414214 $zmax) // 14
+ (-1.414214 1.414214 $zmax) // 15
+);
+
+blocks
+(
+hex (0 1 5 4 8 9 13 12) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (1 2 6 5 9 10 14 13) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (2 3 7 6 10 11 15 14) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (3 0 4 7 11 8 12 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (4 5 6 7 12 13 14 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+);
+
+edges
+(
+arc 0 1 ( 0 -5 $zmin)
+arc 1 2 ( 5 0 $zmin)
+arc 2 3 ( 0 5 $zmin)
+arc 3 0 (-5 0 $zmin)
+arc 4 5 ( 0 -1.5 $zmin)
+arc 5 6 ( 1.5 0 $zmin)
+arc 6 7 ( 0 1.5 $zmin)
+arc 7 4 (-1.5 0 $zmin)
+
+arc 8 9 ( 0 -5 $zmax)
+arc 9 10 ( 5 0 $zmax)
+arc 10 11 ( 0 5 $zmax)
+arc 11 8 (-5 0 $zmax)
+arc 12 13 ( 0 -1.5 $zmax)
+arc 13 14 (1.5 0 $zmax)
+arc 14 15 ( 0 1.5 $zmax)
+arc 15 12 (-1.5 0 $zmax)
+);
+
+
+patches
+(
+
+ patch fixedWalls
+ (
+ (0 1 9 8)
+ (1 2 10 9)
+ (2 3 11 10)
+ (3 0 8 11)
+ )
+
+ patch inlet
+ (
+ (0 1 5 4)
+ (1 2 6 5)
+ (2 3 7 6)
+ (3 0 4 7)
+ (4 5 6 7)
+ )
+
+ patch outlet
+ (
+ (8 9 13 12)
+ (9 10 14 13)
+ (10 11 15 14)
+ (12 13 14 15)
+ (11 8 12 15)
+ )
+);
+
+mergePatchPairs
+(
+);
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/controlDict b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/controlDict
new file mode 100644
index 000000000..162aef6ed
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/controlDict
@@ -0,0 +1,45 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object controlDict;
+}
+
+application sonicLiquidFoam;
+
+startFrom startTime;
+
+startTime 0;
+
+stopAt endTime;
+
+endTime 10.0;
+
+deltaT 0.01;
+
+writeControl adjustableRunTime;
+
+writeInterval 0.01;
+
+purgeWrite 0;
+
+writeFormat ascii;
+
+writePrecision 6;
+
+writeCompression off;
+
+timeFormat general;
+
+timePrecision 6;
+
+functions
+{
+ preCICE_Adapter
+ {
+ type preciceAdapterFunctionObject;
+ libs ("libpreciceAdapterFunctionObject.so");
+ }
+}
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/decomposeParDict b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/decomposeParDict
new file mode 100644
index 000000000..ad99cf6c5
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/decomposeParDict
@@ -0,0 +1,16 @@
+FoamFile {
+ version 2.0;
+ class dictionary;
+ object decomposeParDict;
+ format ascii;
+}
+
+numberOfSubdomains 2;
+
+method simple;
+
+simpleCoeffs
+{
+ n (2 1 1);
+ delta 0.001;
+}
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/fvSchemes b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/fvSchemes
new file mode 100644
index 000000000..edf56a6dc
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/fvSchemes
@@ -0,0 +1,40 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object fvSchemes;
+}
+
+ddtSchemes
+{
+ default CrankNicolson 0.45;
+}
+
+gradSchemes
+{
+ default Gauss linear;
+}
+
+divSchemes
+{
+ default none;
+ div(phi,U) Gauss limitedLinearV 1;
+ div(phid,p) Gauss limitedLinear 1;
+}
+
+laplacianSchemes
+{
+ default Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+ default linear;
+}
+
+snGradSchemes
+{
+ default corrected;
+}
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/fvSolution b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/fvSolution
new file mode 100644
index 000000000..506c2ecf8
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/fvSolution
@@ -0,0 +1,43 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object fvSolution;
+}
+
+solvers
+{
+ "p.*"
+ {
+ solver PBiCG;
+ preconditioner DILU
+ tolerance 1e-06;
+ relTol 0.01;
+ }
+
+ "U.*"
+ {
+ $p;
+ solver PBiCG;
+ preconditioner DILU;
+ tolerance 1e-05;
+ relTol 0.1;
+ }
+
+ "rho.*"
+ {
+ solver PCG;
+ preconditioner DIC;
+ tolerance 1e-05;
+ relTol 0.1;
+ }
+}
+
+PIMPLE
+{
+ nOuterCorrectors 4;
+ nCorrectors 2;
+ nNonOrthogonalCorrectors 0;
+}
diff --git a/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/preciceDict b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/preciceDict
new file mode 100644
index 000000000..b496662d1
--- /dev/null
+++ b/partitioned-pipe/fluid1-openfoam-sonicliquidfoam/system/preciceDict
@@ -0,0 +1,34 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object preciceDict;
+}
+
+preciceConfig "../precice-config.xml";
+
+participant Fluid1;
+
+modules (FF);
+
+interfaces
+{
+ Interface1
+ {
+ mesh Fluid1-Mesh;
+ patches (outlet);
+
+ readData
+ (
+ Pressure
+ );
+
+ writeData
+ (
+ Velocity
+ PressureGradient
+ );
+ };
+};
\ No newline at end of file
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/0/U b/partitioned-pipe/fluid2-openfoam-pimplefoam/0/U
new file mode 100644
index 000000000..94afa03ee
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/0/U
@@ -0,0 +1,30 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volVectorField;
+ location "0";
+ object U;
+}
+
+dimensions [0 1 -1 0 0 0 0];
+
+internalField uniform (0 0 0);
+
+boundaryField
+{
+ inlet
+ {
+ type fixedValue;
+ value $internalField;
+ }
+ outlet
+ {
+ type fixedGradient;
+ gradient uniform (0 0 0);
+ }
+ fixedWalls
+ {
+ type noSlip;
+ }
+}
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/0/p b/partitioned-pipe/fluid2-openfoam-pimplefoam/0/p
new file mode 100644
index 000000000..ada3a6d88
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/0/p
@@ -0,0 +1,31 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ object p;
+}
+
+dimensions [0 2 -2 0 0 0 0];
+
+internalField uniform 0;
+
+boundaryField
+{
+ inlet
+ {
+ type fixedGradient;
+ gradient uniform 0;
+ }
+
+ outlet
+ {
+ type fixedValue;
+ value uniform 0;
+ }
+
+ fixedWalls
+ {
+ type zeroGradient;
+ }
+}
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/clean.sh b/partitioned-pipe/fluid2-openfoam-pimplefoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/constant/transportProperties b/partitioned-pipe/fluid2-openfoam-pimplefoam/constant/transportProperties
new file mode 100644
index 000000000..c055a4bfa
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/constant/transportProperties
@@ -0,0 +1,12 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object transportProperties;
+}
+
+transportModel Newtonian;
+
+nu nu [ 0 2 -1 0 0 0 0 ] 1e1;
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/constant/turbulenceProperties b/partitioned-pipe/fluid2-openfoam-pimplefoam/constant/turbulenceProperties
new file mode 100644
index 000000000..2c55a8b28
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/constant/turbulenceProperties
@@ -0,0 +1,10 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object turbulenceProperties;
+}
+
+simulationType laminar;
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/run.sh b/partitioned-pipe/fluid2-openfoam-pimplefoam/run.sh
new file mode 100755
index 000000000..d00617f49
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid2-openfoam-pimplefoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/system/blockMeshDict b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/blockMeshDict
new file mode 100644
index 000000000..56363d94b
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/blockMeshDict
@@ -0,0 +1,104 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant/polyMesh";
+ object blockMeshDict;
+}
+
+convertToMeters 1;
+
+
+zmin 20;
+zmax 40;
+
+xcells 10; // per block (5 blocks)
+ycells 10; // per block (5 blocks)
+zcells 20;
+
+vertices
+(
+ (-3.535534 -3.535534 $zmin) // 0
+ ( 3.535534 -3.535534 $zmin) // 1
+ ( 3.535534 3.535534 $zmin) // 2
+ (-3.535534 3.535534 $zmin) // 3
+ (-1.414214 -1.414214 $zmin) // 4
+ ( 1.414214 -1.414214 $zmin) // 5
+ ( 1.414214 1.414214 $zmin) // 6
+ (-1.414214 1.414214 $zmin) // 7
+
+ (-3.535534 -3.535534 $zmax) // 8
+ ( 3.535534 -3.535534 $zmax) // 9
+ ( 3.535534 3.535534 $zmax) // 10
+ (-3.535534 3.535534 $zmax) // 11
+ (-1.414214 -1.414214 $zmax) // 12
+ ( 1.414214 -1.414214 $zmax) // 13
+ ( 1.414214 1.414214 $zmax) // 14
+ (-1.414214 1.414214 $zmax) // 15
+);
+
+blocks
+(
+hex (0 1 5 4 8 9 13 12) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (1 2 6 5 9 10 14 13) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (2 3 7 6 10 11 15 14) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (3 0 4 7 11 8 12 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (4 5 6 7 12 13 14 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+);
+
+edges
+(
+arc 0 1 ( 0 -5 $zmin)
+arc 1 2 ( 5 0 $zmin)
+arc 2 3 ( 0 5 $zmin)
+arc 3 0 (-5 0 $zmin)
+arc 4 5 ( 0 -1.5 $zmin)
+arc 5 6 ( 1.5 0 $zmin)
+arc 6 7 ( 0 1.5 $zmin)
+arc 7 4 (-1.5 0 $zmin)
+
+arc 8 9 ( 0 -5 $zmax)
+arc 9 10 ( 5 0 $zmax)
+arc 10 11 ( 0 5 $zmax)
+arc 11 8 (-5 0 $zmax)
+arc 12 13 ( 0 -1.5 $zmax)
+arc 13 14 (1.5 0 $zmax)
+arc 14 15 ( 0 1.5 $zmax)
+arc 15 12 (-1.5 0 $zmax)
+);
+
+
+patches
+(
+
+ patch fixedWalls
+ (
+ (0 1 9 8)
+ (1 2 10 9)
+ (2 3 11 10)
+ (3 0 8 11)
+ )
+
+ patch inlet
+ (
+ (0 1 5 4)
+ (1 2 6 5)
+ (2 3 7 6)
+ (3 0 4 7)
+ (4 5 6 7)
+ )
+
+ patch outlet
+ (
+ (8 9 13 12)
+ (9 10 14 13)
+ (10 11 15 14)
+ (12 13 14 15)
+ (11 8 12 15)
+ )
+);
+
+mergePatchPairs
+(
+);
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/system/controlDict b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/controlDict
new file mode 100644
index 000000000..9fe0ab9f5
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/controlDict
@@ -0,0 +1,45 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object controlDict;
+}
+
+application pimpleFoam;
+
+startFrom startTime;
+
+startTime 0;
+
+stopAt endTime;
+
+endTime 10.0;
+
+deltaT 0.01;
+
+writeControl adjustableRunTime;
+
+writeInterval 0.01;
+
+purgeWrite 0;
+
+writeFormat ascii;
+
+writePrecision 6;
+
+writeCompression off;
+
+timeFormat general;
+
+timePrecision 6;
+
+functions
+{
+ preCICE_Adapter
+ {
+ type preciceAdapterFunctionObject;
+ libs ("libpreciceAdapterFunctionObject.so");
+ }
+}
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/system/decomposeParDict b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/decomposeParDict
new file mode 100644
index 000000000..ad99cf6c5
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/decomposeParDict
@@ -0,0 +1,16 @@
+FoamFile {
+ version 2.0;
+ class dictionary;
+ object decomposeParDict;
+ format ascii;
+}
+
+numberOfSubdomains 2;
+
+method simple;
+
+simpleCoeffs
+{
+ n (2 1 1);
+ delta 0.001;
+}
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/system/fvSchemes b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/fvSchemes
new file mode 100644
index 000000000..a22010ae4
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/fvSchemes
@@ -0,0 +1,40 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object fvSchemes;
+}
+
+ddtSchemes
+{
+ default Euler;
+}
+
+gradSchemes
+{
+ default Gauss linear;
+}
+
+divSchemes
+{
+ default none;
+ div(phi,U) bounded Gauss upwind;
+ div((nuEff*dev2(T(grad(U))))) Gauss linear;
+}
+
+laplacianSchemes
+{
+ default Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+ default linear;
+}
+
+snGradSchemes
+{
+ default corrected;
+}
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/fvSolution b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/fvSolution
similarity index 82%
rename from FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/fvSolution
rename to partitioned-pipe/fluid2-openfoam-pimplefoam/system/fvSolution
index 134915d5f..7e4fe2724 100644
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/fvSolution
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/fvSolution
@@ -6,7 +6,6 @@ FoamFile
location "system";
object fvSolution;
}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
solvers
{
@@ -62,8 +61,6 @@ PIMPLE
{
nCorrectors 4;
nNonOrthogonalCorrectors 1;
- // tolerance 1.0e-14;
- // relTol 5e-3;
consistent true;
correctPhi true;
momentumPredictor true;
@@ -75,7 +72,3 @@ potentialFlow
{
nNonOrthogonalCorrectors 10;
}
-
-
-
-// ************************************************************************* //
diff --git a/partitioned-pipe/fluid2-openfoam-pimplefoam/system/preciceDict b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/preciceDict
new file mode 100644
index 000000000..f17b23d93
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-pimplefoam/system/preciceDict
@@ -0,0 +1,34 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object preciceDict;
+}
+
+preciceConfig "../precice-config.xml";
+
+participant Fluid2;
+
+modules (FF);
+
+interfaces
+{
+ Interface1
+ {
+ mesh Fluid2-Mesh;
+ patches (inlet);
+
+ readData
+ (
+ Velocity
+ PressureGradient
+ );
+
+ writeData
+ (
+ Pressure
+ );
+ };
+};
\ No newline at end of file
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/0/U b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/0/U
new file mode 100644
index 000000000..94afa03ee
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/0/U
@@ -0,0 +1,30 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volVectorField;
+ location "0";
+ object U;
+}
+
+dimensions [0 1 -1 0 0 0 0];
+
+internalField uniform (0 0 0);
+
+boundaryField
+{
+ inlet
+ {
+ type fixedValue;
+ value $internalField;
+ }
+ outlet
+ {
+ type fixedGradient;
+ gradient uniform (0 0 0);
+ }
+ fixedWalls
+ {
+ type noSlip;
+ }
+}
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/0/p b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/0/p
new file mode 100644
index 000000000..eefaf12bd
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/0/p
@@ -0,0 +1,31 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class volScalarField;
+ object p;
+}
+
+dimensions [1 -1 -2 0 0 0 0];
+
+internalField uniform 0;
+
+boundaryField
+{
+ inlet
+ {
+ type fixedGradient;
+ gradient uniform 0;
+ }
+
+ outlet
+ {
+ type fixedValue;
+ value uniform 0;
+ }
+
+ fixedWalls
+ {
+ type zeroGradient;
+ }
+}
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/clean.sh b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/thermodynamicProperties b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/thermodynamicProperties
new file mode 100644
index 000000000..aa3c63f53
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/thermodynamicProperties
@@ -0,0 +1,15 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object thermodynamicProperties;
+}
+
+rho0 rho0 [1 -3 0 0 0 0 0] 1;
+
+p0 p0 [1 -1 -2 0 0 0 0] 100000;
+
+psi psi [0 -2 2 0 0 0 0] 4.54e-07;
+
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/transportProperties b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/transportProperties
new file mode 100644
index 000000000..0f39f4183
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/transportProperties
@@ -0,0 +1,10 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object transportProperties;
+}
+
+mu mu [1 -1 -1 0 0 0 0] 1e1;
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/turbulenceProperties b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/turbulenceProperties
new file mode 100644
index 000000000..2c55a8b28
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/constant/turbulenceProperties
@@ -0,0 +1,10 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant";
+ object turbulenceProperties;
+}
+
+simulationType laminar;
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/run.sh b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/run.sh
new file mode 100755
index 000000000..5a24175c5
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid2-openfoam-sonicliquidfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/blockMeshDict b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/blockMeshDict
new file mode 100644
index 000000000..56363d94b
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/blockMeshDict
@@ -0,0 +1,104 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "constant/polyMesh";
+ object blockMeshDict;
+}
+
+convertToMeters 1;
+
+
+zmin 20;
+zmax 40;
+
+xcells 10; // per block (5 blocks)
+ycells 10; // per block (5 blocks)
+zcells 20;
+
+vertices
+(
+ (-3.535534 -3.535534 $zmin) // 0
+ ( 3.535534 -3.535534 $zmin) // 1
+ ( 3.535534 3.535534 $zmin) // 2
+ (-3.535534 3.535534 $zmin) // 3
+ (-1.414214 -1.414214 $zmin) // 4
+ ( 1.414214 -1.414214 $zmin) // 5
+ ( 1.414214 1.414214 $zmin) // 6
+ (-1.414214 1.414214 $zmin) // 7
+
+ (-3.535534 -3.535534 $zmax) // 8
+ ( 3.535534 -3.535534 $zmax) // 9
+ ( 3.535534 3.535534 $zmax) // 10
+ (-3.535534 3.535534 $zmax) // 11
+ (-1.414214 -1.414214 $zmax) // 12
+ ( 1.414214 -1.414214 $zmax) // 13
+ ( 1.414214 1.414214 $zmax) // 14
+ (-1.414214 1.414214 $zmax) // 15
+);
+
+blocks
+(
+hex (0 1 5 4 8 9 13 12) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (1 2 6 5 9 10 14 13) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (2 3 7 6 10 11 15 14) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (3 0 4 7 11 8 12 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+hex (4 5 6 7 12 13 14 15) pipe ($xcells $ycells $zcells) edgeGrading (1 1 1 1 1 1 1 1 1 1 1 1)
+);
+
+edges
+(
+arc 0 1 ( 0 -5 $zmin)
+arc 1 2 ( 5 0 $zmin)
+arc 2 3 ( 0 5 $zmin)
+arc 3 0 (-5 0 $zmin)
+arc 4 5 ( 0 -1.5 $zmin)
+arc 5 6 ( 1.5 0 $zmin)
+arc 6 7 ( 0 1.5 $zmin)
+arc 7 4 (-1.5 0 $zmin)
+
+arc 8 9 ( 0 -5 $zmax)
+arc 9 10 ( 5 0 $zmax)
+arc 10 11 ( 0 5 $zmax)
+arc 11 8 (-5 0 $zmax)
+arc 12 13 ( 0 -1.5 $zmax)
+arc 13 14 (1.5 0 $zmax)
+arc 14 15 ( 0 1.5 $zmax)
+arc 15 12 (-1.5 0 $zmax)
+);
+
+
+patches
+(
+
+ patch fixedWalls
+ (
+ (0 1 9 8)
+ (1 2 10 9)
+ (2 3 11 10)
+ (3 0 8 11)
+ )
+
+ patch inlet
+ (
+ (0 1 5 4)
+ (1 2 6 5)
+ (2 3 7 6)
+ (3 0 4 7)
+ (4 5 6 7)
+ )
+
+ patch outlet
+ (
+ (8 9 13 12)
+ (9 10 14 13)
+ (10 11 15 14)
+ (12 13 14 15)
+ (11 8 12 15)
+ )
+);
+
+mergePatchPairs
+(
+);
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/controlDict b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/controlDict
new file mode 100644
index 000000000..162aef6ed
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/controlDict
@@ -0,0 +1,45 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object controlDict;
+}
+
+application sonicLiquidFoam;
+
+startFrom startTime;
+
+startTime 0;
+
+stopAt endTime;
+
+endTime 10.0;
+
+deltaT 0.01;
+
+writeControl adjustableRunTime;
+
+writeInterval 0.01;
+
+purgeWrite 0;
+
+writeFormat ascii;
+
+writePrecision 6;
+
+writeCompression off;
+
+timeFormat general;
+
+timePrecision 6;
+
+functions
+{
+ preCICE_Adapter
+ {
+ type preciceAdapterFunctionObject;
+ libs ("libpreciceAdapterFunctionObject.so");
+ }
+}
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/decomposeParDict b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/decomposeParDict
new file mode 100644
index 000000000..ad99cf6c5
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/decomposeParDict
@@ -0,0 +1,16 @@
+FoamFile {
+ version 2.0;
+ class dictionary;
+ object decomposeParDict;
+ format ascii;
+}
+
+numberOfSubdomains 2;
+
+method simple;
+
+simpleCoeffs
+{
+ n (2 1 1);
+ delta 0.001;
+}
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/fvSchemes b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/fvSchemes
new file mode 100644
index 000000000..edf56a6dc
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/fvSchemes
@@ -0,0 +1,40 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object fvSchemes;
+}
+
+ddtSchemes
+{
+ default CrankNicolson 0.45;
+}
+
+gradSchemes
+{
+ default Gauss linear;
+}
+
+divSchemes
+{
+ default none;
+ div(phi,U) Gauss limitedLinearV 1;
+ div(phid,p) Gauss limitedLinear 1;
+}
+
+laplacianSchemes
+{
+ default Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+ default linear;
+}
+
+snGradSchemes
+{
+ default corrected;
+}
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/fvSolution b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/fvSolution
new file mode 100644
index 000000000..506c2ecf8
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/fvSolution
@@ -0,0 +1,43 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object fvSolution;
+}
+
+solvers
+{
+ "p.*"
+ {
+ solver PBiCG;
+ preconditioner DILU
+ tolerance 1e-06;
+ relTol 0.01;
+ }
+
+ "U.*"
+ {
+ $p;
+ solver PBiCG;
+ preconditioner DILU;
+ tolerance 1e-05;
+ relTol 0.1;
+ }
+
+ "rho.*"
+ {
+ solver PCG;
+ preconditioner DIC;
+ tolerance 1e-05;
+ relTol 0.1;
+ }
+}
+
+PIMPLE
+{
+ nOuterCorrectors 4;
+ nCorrectors 2;
+ nNonOrthogonalCorrectors 0;
+}
diff --git a/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/preciceDict b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/preciceDict
new file mode 100644
index 000000000..f17b23d93
--- /dev/null
+++ b/partitioned-pipe/fluid2-openfoam-sonicliquidfoam/system/preciceDict
@@ -0,0 +1,34 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ location "system";
+ object preciceDict;
+}
+
+preciceConfig "../precice-config.xml";
+
+participant Fluid2;
+
+modules (FF);
+
+interfaces
+{
+ Interface1
+ {
+ mesh Fluid2-Mesh;
+ patches (inlet);
+
+ readData
+ (
+ Velocity
+ PressureGradient
+ );
+
+ writeData
+ (
+ Pressure
+ );
+ };
+};
\ No newline at end of file
diff --git a/partitioned-pipe/images/tutorials-partitioned-pipe-results-pimpleFoam-sonicliquidfoam.png b/partitioned-pipe/images/tutorials-partitioned-pipe-results-pimpleFoam-sonicliquidfoam.png
new file mode 100644
index 000000000..919d5193f
Binary files /dev/null and b/partitioned-pipe/images/tutorials-partitioned-pipe-results-pimpleFoam-sonicliquidfoam.png differ
diff --git a/partitioned-pipe/precice-config.xml b/partitioned-pipe/precice-config.xml
new file mode 100644
index 000000000..1a8cf842f
--- /dev/null
+++ b/partitioned-pipe/precice-config.xml
@@ -0,0 +1,79 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/perpendicular-flap/README.md b/perpendicular-flap/README.md
new file mode 100644
index 000000000..1b222f6ea
--- /dev/null
+++ b/perpendicular-flap/README.md
@@ -0,0 +1,70 @@
+---
+title: Perpendicular flap
+permalink: tutorials-perpendicular-flap.html
+keywords: fluid-structure interaction, FSI, OpenFOAM, FEniCS, Nutils, deal.II, Calculix, SU2,
+summary: This tutorial describes how to run a fluid-structure interaction using preCICE and any fluid-solid solver combination of our [officially provided adapter codes](adapters-overview.html).
+---
+
+## Setup
+
+We model a two-dimensional fluid flowing through a channel. A solid, elastic flap is fixed to the floor of this channel. The flap oscillates due to the fluid pressure building up on its surface. The setup is shown schematically here:
+
+
+
+The simulated flow domain is 6 units long (x) and 4 units tall (y). The flap is located at the center of the bottom (x=0) and is 1 unit long (y) and 0.1 units thick (x). We set the fluid density $$ \rho_F= 1.0kg/m^{3} $$, the kinematic viscosity $$ \nu_f= 1.0m^{2}/s $$, the solid density $$ \rho_s= 3.0·10^{3}kg/m^{3} $$, the Young’s modulus to $$ E= 4.0·10^{6} kg/ms^{2} $$ and the Poisson ratio $$ \nu_s = 0.3 $$. On the left boundary a constant inflow profile in x-direction of 10m/s is prescribed. The right boundary is an outflow and the top and bottom of the channel as well as the surface of the flap are no-slip walls.
+
+## Available solvers
+
+Fluid participant:
+
+* OpenFOAM. For older OpenFOAM versions, the solver name differs: If you are using OpenFOAM v1712 / 5.x or older have a look at `fluid-openfoam/system/controlDict` and set the appropriate solver name. The solver can run in parallel using the command line argument `run.sh -parallel`. For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+* Nutils. For more information, have a look at the [Nutils adapter documentation](adapter-nutils-overview.html). This Nutils solver requires at least Nutils v6.0.
+
+* SU2. As opposed to the other two fluid codes, SU2 is in particular specialized for compressible flow. Therefore the default simulation parameters haven been adjusted in order to pull the setup into the compressible flow regime. For more information, have a look at the [SU2 adapter documentation](adapter-su2-overview.html).
+
+Solid participant:
+
+* FEniCS. The structural model is currently limited to linear elasticity. For more information, have a look at the [FeniCS adapter documentation](adapter-fenics.html).
+
+* CalculiX. In order to allow a reasonable comparison to all solid codes, the geometrically non-linear solver has been disabled and only a linear model is used by default. For more information, have a look at the [CalculiX adapter documentation](adapter-calculix-overview.html)
+
+* deal.II. This tutorial is intended to be used with the linear solid solver, but works with the nonlinear solver as well. Please copy the solver executables to the `solid-dealii` folder or make it discoverable at runtime and update the `solid-dealii/run.sh` script. For more information, have a look at the [deal.II adapter documentation](adapter-dealii-overview.html).
+
+## Running the Simulation
+
+All listed solvers can be used in order to run the simulation. Open two separate terminals and start the desired fluid and solid participant by calling the respective run script `run.sh` located in the participant directory. For example:
+
+```
+cd fluid-openfoam
+./run.sh
+```
+and
+```
+cd solid-fenics
+./run.sh
+```
+in order to use OpenFOAM and FEniCS for this test case.
+
+
+## Post-processing
+
+How to visualize the simulation results depends on the selected solvers. Most of the solvers generate `vtk` files which can visualized using, e.g., ParaView.
+
+CalculiX exports results in `.frd` format, which you can visualize in CGX (`cgx flap.frd`). In the CGX window, you can click-and-hold to select different times and fields, or to animate the geometry. If you prefer to work with VTK files, you can also use tools such as [ccx2paraview](https://github.com/calculix/ccx2paraview) or a converter included in the [calculix-adapter/tools](https://github.com/precice/calculix-adapter/tree/master/tools) directory.
+
+As we defined a watchpoint on the 'Solid' participant at the flap tip (see `precice-config.xml`), we can plot it with gnuplot using the script `plot-displacement.sh.` You need to specify the directory of the selected solid participant as a command line argument, so that the script can pick-up the desired watchpoint file, e.g. `plot-displacement.sh solid-fenics`. The resulting graph shows the x displacement of the flap tip. You can modify the script to plot the force instead.
+
+
+
+
+There is moreover a script `plot-all-displacements.sh` to plot and compare all possible variants. This script expects all watchpoint logs to be available in a subfolder `watchpoints` in the format `openfoam-dealii.log` or similar. If you want to use this script, you need to copy the files over accordingly.
+
+You should get results similar to this one:
+
+
+
+Reasons for the differences:
+
+* The CalculiX adapter only supports linear finite elements (deal.II uses 4th order, FEniCS 2nd order).
+* SU2 models a compressible fluid, OpenFOAM and Nutils an incompressible one.
diff --git a/perpendicular-flap/clean-tutorial.sh b/perpendicular-flap/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/perpendicular-flap/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/perpendicular-flap/fluid-nutils/clean.sh b/perpendicular-flap/fluid-nutils/clean.sh
new file mode 100755
index 000000000..6893c1ea5
--- /dev/null
+++ b/perpendicular-flap/fluid-nutils/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_nutils .
diff --git a/perpendicular-flap/fluid-nutils/fluid.py b/perpendicular-flap/fluid-nutils/fluid.py
new file mode 100644
index 000000000..e0e6b15fc
--- /dev/null
+++ b/perpendicular-flap/fluid-nutils/fluid.py
@@ -0,0 +1,237 @@
+#! /usr/bin/env python3
+
+from nutils import mesh, function, solver, export, cli
+import numpy
+import treelog
+import precice
+
+# for details on this solver see https://doi.org/10.1002/nme.6443
+
+# some helper function to shift variables by one timestep
+
+
+@function.replace
+def subs0(f):
+ if isinstance(f, function.Argument) and f._name == 'lhs':
+ return function.Argument(name='lhs0', shape=f.shape, nderiv=f._nderiv)
+ if isinstance(f, function.Argument) and f._name == 'meshdofs':
+ return function.Argument(name='oldmeshdofs', shape=f.shape, nderiv=f._nderiv)
+ if isinstance(f, function.Argument) and f._name == 'oldmeshdofs':
+ return function.Argument(name='oldoldmeshdofs', shape=f.shape, nderiv=f._nderiv)
+ if isinstance(f, function.Argument) and f._name == 'oldoldmeshdofs':
+ return function.Argument(name='oldoldoldmeshdofs', shape=f.shape, nderiv=f._nderiv)
+
+# some helper function to shift variables by two timesteps
+
+
+@function.replace
+def subs00(f):
+ if isinstance(f, function.Argument) and f._name == 'lhs':
+ return function.Argument(name='lhs00', shape=f.shape, nderiv=f._nderiv)
+
+
+def main(inflow: 'inflow velocity' = 10,
+ viscosity: 'kinematic viscosity' = 1.0,
+ density: 'density' = 1.0,
+ theta=0.5,
+ timestepsize=0.01):
+
+ # mesh and geometry definition
+ grid_x_1 = numpy.linspace(-3, -1, 7)
+ grid_x_1 = grid_x_1[:-1]
+ grid_x_2 = numpy.linspace(-1, -0.3, 8)
+ grid_x_2 = grid_x_2[:-1]
+ grid_x_3 = numpy.linspace(-0.3, 0.3, 13)
+ grid_x_3 = grid_x_3[:-1]
+ grid_x_4 = numpy.linspace(0.3, 1, 8)
+ grid_x_4 = grid_x_4[:-1]
+ grid_x_5 = numpy.linspace(1, 3, 7)
+ grid_x = numpy.concatenate((grid_x_1, grid_x_2, grid_x_3, grid_x_4, grid_x_5), axis=None)
+ grid_y_1 = numpy.linspace(0, 1.5, 16)
+ grid_y_1 = grid_y_1[:-1]
+ grid_y_2 = numpy.linspace(1.5, 2, 4)
+ grid_y_2 = grid_y_2[:-1]
+ grid_y_3 = numpy.linspace(2, 4, 7)
+ grid_y = numpy.concatenate((grid_y_1, grid_y_2, grid_y_3), axis=None)
+ grid = [grid_x, grid_y]
+
+ topo, geom = mesh.rectilinear(grid)
+ domain = topo.withboundary(inflow='left', wall='top,bottom', outflow='right') - \
+ topo[18:20, :10].withboundary(flap='left,right,top')
+
+ # Nutils namespace
+ ns = function.Namespace()
+
+ # time approximations
+ # TR interpolation
+ ns._functions['t'] = lambda f: theta * f + (1 - theta) * subs0(f)
+ ns._functions_nargs['t'] = 1
+ # 1st order FD
+ ns._functions['δt'] = lambda f: (f - subs0(f)) / dt
+ ns._functions_nargs['δt'] = 1
+ # 2nd order FD
+ ns._functions['tt'] = lambda f: (1.5 * f - 2 * subs0(f) + 0.5 * subs00(f)) / dt
+ ns._functions_nargs['tt'] = 1
+ # extrapolation for pressure
+ ns._functions['tp'] = lambda f: (1.5 * f - 0.5 * subs0(f))
+ ns._functions_nargs['tp'] = 1
+
+ ns.nu = viscosity
+ ns.rho = density
+ ns.uin = inflow
+ ns.x0 = geom # reference geometry
+ ns.dbasis = domain.basis('std', degree=1).vector(2)
+ ns.d_i = 'dbasis_ni ?meshdofs_n'
+ ns.umesh_i = 'dbasis_ni (1.5 ?meshdofs_n - 2 ?oldmeshdofs_n + 0.5 ?oldoldmeshdofs_n ) / ?dt'
+ ns.x_i = 'x0_i + d_i' # moving geometry
+ ns.ubasis, ns.pbasis = function.chain([domain.basis('std', degree=2).vector(2), domain.basis('std', degree=1), ])
+ ns.F_i = 'ubasis_ni ?F_n' # stress field
+ ns.urel_i = 'ubasis_ni ?lhs_n' # relative velocity
+ ns.u_i = 'umesh_i + urel_i' # total velocity
+ ns.p = 'pbasis_n ?lhs_n' # pressure
+
+ # initialization of dofs
+ meshdofs = numpy.zeros(len(ns.dbasis))
+ oldmeshdofs = meshdofs
+ oldoldmeshdofs = meshdofs
+ oldoldoldmeshdofs = meshdofs
+ lhs0 = numpy.zeros(len(ns.ubasis))
+
+ # for visualization
+ bezier = domain.sample('bezier', 2)
+
+ # preCICE setup
+ configFileName = "../precice-config.xml"
+ participantName = "Fluid"
+ solverProcessIndex = 0
+ solverProcessSize = 1
+ interface = precice.Interface(participantName, configFileName, solverProcessIndex, solverProcessSize)
+
+ # define coupling meshes
+ meshName = "Fluid-Mesh"
+ meshID = interface.get_mesh_id(meshName)
+
+ couplinginterface = domain.boundary['flap']
+ couplingsample = couplinginterface.sample('gauss', degree=2) # mesh located at Gauss points
+ dataIndices = interface.set_mesh_vertices(meshID, couplingsample.eval(ns.x0))
+
+ # coupling data
+ writeData = "Force"
+ readData = "Displacement"
+ writedataID = interface.get_data_id(writeData, meshID)
+ readdataID = interface.get_data_id(readData, meshID)
+
+ # initialize preCICE
+ precice_dt = interface.initialize()
+ dt = min(precice_dt, timestepsize)
+
+ # boundary conditions for fluid equations
+ sqr = domain.boundary['wall,flap'].integral('urel_k urel_k d:x0' @ ns, degree=4)
+ cons = solver.optimize('lhs', sqr, droptol=1e-15)
+ sqr = domain.boundary['inflow'].integral('((urel_0 - uin)^2 + urel_1^2) d:x0' @ ns, degree=4)
+ cons = solver.optimize('lhs', sqr, droptol=1e-15, constrain=cons)
+
+ # weak form fluid equations
+ res = domain.integral('t(ubasis_ni,j (u_i,j + u_j,i) rho nu d:x)' @ ns, degree=4)
+ res += domain.integral('(-ubasis_ni,j p δ_ij + pbasis_n u_k,k) d:x' @ ns, degree=4)
+ res += domain.integral('rho ubasis_ni δt(u_i d:x)' @ ns, degree=4)
+ res += domain.integral('rho ubasis_ni t(u_i,j urel_j d:x)' @ ns, degree=4)
+
+ # weak form for force computation
+ resF = domain.integral('(ubasis_ni,j (u_i,j + u_j,i) rho nu d:x)' @ ns, degree=4)
+ resF += domain.integral('tp(-ubasis_ni,j p δ_ij d:x)' @ ns, degree=4)
+ resF += domain.integral('pbasis_n u_k,k d:x' @ ns, degree=4)
+ resF += domain.integral('rho ubasis_ni tt(u_i d:x)' @ ns, degree=4)
+ resF += domain.integral('rho ubasis_ni (u_i,j urel_j d:x)' @ ns, degree=4)
+ resF += couplinginterface.sample('gauss', 4).integral('ubasis_ni F_i d:x' @ ns)
+ consF = numpy.isnan(solver.optimize('F', couplinginterface.sample('gauss', 4).integral('F_i F_i' @ ns),
+ droptol=1e-10))
+
+ # boundary conditions mesh displacements
+ sqr = domain.boundary['inflow,outflow,wall'].integral('d_i d_i' @ ns, degree=2)
+ meshcons0 = solver.optimize('meshdofs', sqr, droptol=1e-15)
+
+ # weak form mesh displacements
+ meshsqr = domain.integral('d_i,x0_j d_i,x0_j d:x0' @ ns, degree=2)
+
+ # better initial guess: start from Stokes solution, comment out for comparison with other solvers
+ #res_stokes = domain.integral('(ubasis_ni,j ((u_i,j + u_j,i) rho nu - p δ_ij) + pbasis_n u_k,k) d:x' @ ns, degree=4)
+ #lhs0 = solver.solve_linear('lhs', res_stokes, constrain=cons, arguments=dict(meshdofs=meshdofs, oldmeshdofs=oldmeshdofs, oldoldmeshdofs=oldoldmeshdofs, oldoldoldmeshdofs=oldoldoldmeshdofs, dt=dt))
+ lhs00 = lhs0
+
+ timestep = 0
+ t = 0
+
+ while interface.is_coupling_ongoing():
+
+ # read displacements from interface
+ if interface.is_read_data_available():
+ readdata = interface.read_block_vector_data(readdataID, dataIndices)
+ coupledata = couplingsample.asfunction(readdata)
+ sqr = couplingsample.integral(((ns.d - coupledata)**2).sum(0))
+ meshcons = solver.optimize('meshdofs', sqr, droptol=1e-15, constrain=meshcons0)
+ meshdofs = solver.optimize('meshdofs', meshsqr, constrain=meshcons)
+
+ # save checkpoint
+ if interface.is_action_required(precice.action_write_iteration_checkpoint()):
+ lhs_checkpoint = lhs0
+ lhs00_checkpoint = lhs00
+ t_checkpoint = t
+ timestep_checkpoint = timestep
+ oldmeshdofs_checkpoint = oldmeshdofs
+ oldoldmeshdofs_checkpoint = oldoldmeshdofs
+ oldoldoldmeshdofs_checkpoint = oldoldoldmeshdofs
+ interface.mark_action_fulfilled(precice.action_write_iteration_checkpoint())
+
+ # solve fluid equations
+ lhs1 = solver.newton('lhs', res, lhs0=lhs0, constrain=cons,
+ arguments=dict(lhs0=lhs0, dt=dt, meshdofs=meshdofs, oldmeshdofs=oldmeshdofs,
+ oldoldmeshdofs=oldoldmeshdofs, oldoldoldmeshdofs=oldoldoldmeshdofs)
+ ).solve(tol=1e-6)
+
+ # write forces to interface
+ if interface.is_write_data_required(dt):
+ F = solver.solve_linear('F', resF, constrain=consF,
+ arguments=dict(lhs00=lhs00, lhs0=lhs0, lhs=lhs1, dt=dt, meshdofs=meshdofs,
+ oldmeshdofs=oldmeshdofs, oldoldmeshdofs=oldoldmeshdofs,
+ oldoldoldmeshdofs=oldoldoldmeshdofs))
+ # writedata = couplingsample.eval(ns.F, F=F) # for stresses
+ writedata = couplingsample.eval('F_i d:x' @ ns, F=F, meshdofs=meshdofs) * \
+ numpy.concatenate([p.weights for p in couplingsample.points])[:, numpy.newaxis]
+ interface.write_block_vector_data(writedataID, dataIndices, writedata)
+
+ # do the coupling
+ precice_dt = interface.advance(dt)
+ dt = min(precice_dt, timestepsize)
+
+ # advance variables
+ timestep += 1
+ t += dt
+ lhs00 = lhs0
+ lhs0 = lhs1
+ oldoldoldmeshdofs = oldoldmeshdofs
+ oldoldmeshdofs = oldmeshdofs
+ oldmeshdofs = meshdofs
+
+ # read checkpoint if required
+ if interface.is_action_required(precice.action_read_iteration_checkpoint()):
+ lhs0 = lhs_checkpoint
+ lhs00 = lhs00_checkpoint
+ t = t_checkpoint
+ timestep = timestep_checkpoint
+ oldmeshdofs = oldmeshdofs_checkpoint
+ oldoldmeshdofs = oldoldmeshdofs_checkpoint
+ oldoldoldmeshdofs = oldoldoldmeshdofs_checkpoint
+ interface.mark_action_fulfilled(precice.action_read_iteration_checkpoint())
+
+ if interface.is_time_window_complete():
+ x, u, p = bezier.eval(['x_i', 'u_i', 'p'] @ ns, lhs=lhs1, meshdofs=meshdofs, oldmeshdofs=oldmeshdofs,
+ oldoldmeshdofs=oldoldmeshdofs, oldoldoldmeshdofs=oldoldoldmeshdofs, dt=dt)
+ with treelog.add(treelog.DataLog()):
+ export.vtk('Fluid_' + str(timestep), bezier.tri, x, u=u, p=p)
+
+ interface.finalize()
+
+
+if __name__ == '__main__':
+ cli.run(main)
diff --git a/perpendicular-flap/fluid-nutils/run.sh b/perpendicular-flap/fluid-nutils/run.sh
new file mode 100755
index 000000000..788f40d13
--- /dev/null
+++ b/perpendicular-flap/fluid-nutils/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+python3 fluid.py
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/U b/perpendicular-flap/fluid-openfoam/0/U
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/U
rename to perpendicular-flap/fluid-openfoam/0/U
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/p b/perpendicular-flap/fluid-openfoam/0/p
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/p
rename to perpendicular-flap/fluid-openfoam/0/p
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/phi b/perpendicular-flap/fluid-openfoam/0/phi
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/phi
rename to perpendicular-flap/fluid-openfoam/0/phi
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/pointDisplacement b/perpendicular-flap/fluid-openfoam/0/pointDisplacement
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Fluid/0.orig/pointDisplacement
rename to perpendicular-flap/fluid-openfoam/0/pointDisplacement
diff --git a/perpendicular-flap/fluid-openfoam/clean.sh b/perpendicular-flap/fluid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/perpendicular-flap/fluid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/constant/dynamicMeshDict b/perpendicular-flap/fluid-openfoam/constant/dynamicMeshDict
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/constant/dynamicMeshDict
rename to perpendicular-flap/fluid-openfoam/constant/dynamicMeshDict
diff --git a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/constant/transportProperties b/perpendicular-flap/fluid-openfoam/constant/transportProperties
similarity index 88%
rename from FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/constant/transportProperties
rename to perpendicular-flap/fluid-openfoam/constant/transportProperties
index bc81706ca..a323db90a 100644
--- a/FSI/flap_perp_2D/OpenFOAM-FEniCS/Fluid/constant/transportProperties
+++ b/perpendicular-flap/fluid-openfoam/constant/transportProperties
@@ -10,6 +10,6 @@ FoamFile
transportModel Newtonian;
-nu nu [ 0 2 -1 0 0 0 0 ] 1e-03;
+nu nu [ 0 2 -1 0 0 0 0 ] 1;
// ************************************************************************* //
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/turbulenceProperties b/perpendicular-flap/fluid-openfoam/constant/turbulenceProperties
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/constant/turbulenceProperties
rename to perpendicular-flap/fluid-openfoam/constant/turbulenceProperties
diff --git a/perpendicular-flap/fluid-openfoam/run.sh b/perpendicular-flap/fluid-openfoam/run.sh
new file mode 100755
index 000000000..c191b9e48
--- /dev/null
+++ b/perpendicular-flap/fluid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/blockMeshDict b/perpendicular-flap/fluid-openfoam/system/blockMeshDict
similarity index 70%
rename from FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/blockMeshDict
rename to perpendicular-flap/fluid-openfoam/system/blockMeshDict
index 4570a25ed..4a4116cc3 100644
--- a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/blockMeshDict
+++ b/perpendicular-flap/fluid-openfoam/system/blockMeshDict
@@ -7,51 +7,51 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-scale 1.;
-
-x0 -3.;
+x0 -3.;
x1 -0.05;
x2 0.05;
x3 3.;
-z0 0.;
-z1 1.;
-z2 4.;
+y0 0.;
+y1 1.;
+y2 4.;
+
+z0 0;
+z1 1;
-w 0;
vertices
(
- ($x0 $z0 $w ) // 0
- ($x1 $z0 $w ) // 1
- ($x2 $z0 $w ) // 2
- ($x3 $z0 $w ) // 3
- ($x0 $z1 $w ) // 4
- ($x1 $z1 $w ) // 5
- ($x2 $z1 $w ) // 6
- ($x3 $z1 $w ) // 7
- ($x0 $z2 $w ) // 8
- ($x1 $z2 $w ) // 9
- ($x2 $z2 $w ) // 10
- ($x3 $z2 $w ) // 11
-
- ($x0 $z0 1) // 12
- ($x1 $z0 1) // 13
- ($x2 $z0 1) // 14
- ($x3 $z0 1) // 15
- ($x0 $z1 1) // 16
- ($x1 $z1 1) // 17
- ($x2 $z1 1) // 18
- ($x3 $z1 1) // 19
- ($x0 $z2 1) // 20
- ($x1 $z2 1) // 21
- ($x2 $z2 1) // 22
- ($x3 $z2 1) // 23
+ ($x0 $y0 $z0 ) // 0
+ ($x1 $y0 $z0 ) // 1
+ ($x2 $y0 $z0 ) // 2
+ ($x3 $y0 $z0 ) // 3
+ ($x0 $y1 $z0 ) // 4
+ ($x1 $y1 $z0 ) // 5
+ ($x2 $y1 $z0 ) // 6
+ ($x3 $y1 $z0 ) // 7
+ ($x0 $y2 $z0 ) // 8
+ ($x1 $y2 $z0 ) // 9
+ ($x2 $y2 $z0 ) // 10
+ ($x3 $y2 $z0 ) // 11
+
+ ($x0 $y0 $z1 ) // 12
+ ($x1 $y0 $z1 ) // 13
+ ($x2 $y0 $z1 ) // 14
+ ($x3 $y0 $z1 ) // 15
+ ($x0 $y1 $z1 ) // 16
+ ($x1 $y1 $z1 ) // 17
+ ($x2 $y1 $z1 ) // 18
+ ($x3 $y1 $z1 ) // 19
+ ($x0 $y2 $z1 ) // 20
+ ($x1 $y2 $z1 ) // 21
+ ($x2 $y2 $z1 ) // 22
+ ($x3 $y2 $z1 ) // 23
);
// Grading
-h1 30;
-h2 3;
-v1 15;
+h1 30;
+h2 3;
+v1 15;
v2 30;
blocks
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/controlDict b/perpendicular-flap/fluid-openfoam/system/controlDict
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/controlDict
rename to perpendicular-flap/fluid-openfoam/system/controlDict
diff --git a/FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/decomposeParDict b/perpendicular-flap/fluid-openfoam/system/decomposeParDict
similarity index 100%
rename from FSI/flap_perp_2D/OpenFOAM-deal.II/Fluid/system/decomposeParDict
rename to perpendicular-flap/fluid-openfoam/system/decomposeParDict
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/fvSchemes b/perpendicular-flap/fluid-openfoam/system/fvSchemes
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/fvSchemes
rename to perpendicular-flap/fluid-openfoam/system/fvSchemes
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/fvSolution b/perpendicular-flap/fluid-openfoam/system/fvSolution
similarity index 100%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/fvSolution
rename to perpendicular-flap/fluid-openfoam/system/fvSolution
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/preciceDict b/perpendicular-flap/fluid-openfoam/system/preciceDict
similarity index 58%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/preciceDict
rename to perpendicular-flap/fluid-openfoam/system/preciceDict
index fd11cf9fc..92d739318 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/system/preciceDict
+++ b/perpendicular-flap/fluid-openfoam/system/preciceDict
@@ -7,7 +7,7 @@ FoamFile
object preciceDict;
}
-preciceConfig "precice-config.xml";
+preciceConfig "../precice-config.xml";
participant Fluid;
@@ -17,26 +17,10 @@ interfaces
{
Interface1
{
- mesh Fluid-Mesh-Centers;
+ mesh Fluid-Mesh;
patches (flap);
locations faceCenters;
- readData
- (
- );
-
- writeData
- (
- Stress
- );
- };
-
- Interface2
- {
- mesh Fluid-Mesh-Nodes;
- patches (flap);
- locations faceNodes;
-
readData
(
Displacement
@@ -44,6 +28,7 @@ interfaces
writeData
(
+ Force
);
};
};
@@ -51,4 +36,4 @@ interfaces
FSI
{
rho rho [1 -3 0 0 0 0 0] 1;
-}
\ No newline at end of file
+}
diff --git a/perpendicular-flap/fluid-su2/clean.sh b/perpendicular-flap/fluid-su2/clean.sh
new file mode 100755
index 000000000..54a3623e3
--- /dev/null
+++ b/perpendicular-flap/fluid-su2/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_su2 .
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/Fluid/euler_config_coupled.cfg b/perpendicular-flap/fluid-su2/euler_config_coupled.cfg
similarity index 91%
rename from FSI/flap_perp_2D/SU2-FEniCS/Fluid/euler_config_coupled.cfg
rename to perpendicular-flap/fluid-su2/euler_config_coupled.cfg
index 2fbcd08e2..9c7cea24e 100644
--- a/FSI/flap_perp_2D/SU2-FEniCS/Fluid/euler_config_coupled.cfg
+++ b/perpendicular-flap/fluid-su2/euler_config_coupled.cfg
@@ -14,7 +14,15 @@
PRECICE_USAGE= YES
%
-PRECICE_CONFIG_FILENAME= ./precice-config.xml
+PRECICE_CONFIG_FILENAME= ../precice-config.xml
+%
+PRECICE_PARTICIPANT_NAME= Fluid
+%
+PRECICE_MESH_NAME= Fluid-Mesh
+%
+PRECICE_READ_DATA_NAME= Displacement
+%
+PRECICE_WRITE_DATA_NAME= Force
%
PRECICE_WETSURFACE_MARKER_NAME= wetSurface
%
@@ -39,14 +47,15 @@ MACH_NUMBER= 0.01
% Angle of attack (degrees, only for compressible flows)
AOA= 0.0
%
-% Side-slip angle (degrees, only for compressible flows)
-SIDESLIP_ANGLE= 0.0
+% Free-stream option to choose between density and temperature (default) for
+% initializing the solution (TEMPERATURE_FS, DENSITY_FS)
+FREESTREAM_OPTION= TEMPERATURE_FS
%
% Free-stream pressure (101325.0 N/m^2 by default)
-FREESTREAM_PRESSURE= 101300.0
+FREESTREAM_PRESSURE= 101325.0
%
% Free-stream temperature (288.15 K by default)
-FREESTREAM_TEMPERATURE= 288.0
+FREESTREAM_TEMPERATURE= 288.15
% ------------------------- UNSTEADY SIMULATION -------------------------------%
@@ -58,7 +67,7 @@ UNSTEADY_SIMULATION= DUAL_TIME_STEPPING-1ST_ORDER
UNST_TIMESTEP= 0.01
%
% Total Physical Time for dual time stepping simulations (s)
-UNST_TIME= 6.0
+UNST_TIME= 5.0
%
% Number of internal iterations (dual time method)
UNST_INT_ITER= 200
@@ -78,12 +87,12 @@ GRID_MOVEMENT= YES
GRID_MOVEMENT_KIND= PRECICE_MOVEMENT
%
% Moving wall boundary marker(s) (NONE = no marker, ignored for RIGID_MOTION)
-MARKER_MOVING= ( wetSurface0 )
+MARKER_MOVING= ( wetSurface )
% -------------------- BOUNDARY CONDITION DEFINITION --------------------------%
% Euler wall boundary marker(s) (NONE = no marker)
-MARKER_EULER= ( upper_wall, lower_wall, wetSurface0 )
+MARKER_EULER= ( upper_wall, lower_wall, wetSurface )
%
% Inlet boundary marker(s) (NONE = no marker)
% Format: ( inlet marker, total temperature, total pressure, flow_direction_x,
@@ -92,7 +101,7 @@ MARKER_INLET= ( inlet, 288.6, 101400.0, 1.0, 0.0, 0.0 )
%
% Outlet boundary marker(s) (NONE = no marker)
% Format: ( outlet marker, back pressure (static), ... )
-MARKER_OUTLET= ( outlet, 101300.0 )
+MARKER_OUTLET= ( outlet, 101100.0 )
% ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------%
@@ -199,25 +208,25 @@ STARTCONV_ITER= 10
WRT_RESIDUALS= YES
%
% Mesh input file
-MESH_FILENAME= Fluid/fluidMesh.su2
+MESH_FILENAME= fluidMesh.su2
%
% Mesh input file format (SU2, CGNS, NETCDF_ASCII)
MESH_FORMAT= SU2
%
% Restart flow input file
-SOLUTION_FLOW_FILENAME= Fluid/initial_flow.dat
+SOLUTION_FLOW_FILENAME= initial_flow.dat
%
% Output file format (PARAVIEW, TECPLOT, STL)
OUTPUT_FORMAT= PARAVIEW
%
% Output file with the forces breakdown
-BREAKDOWN_FILENAME= Fluid/forces_breakdown.dat
+BREAKDOWN_FILENAME= forces_breakdown.dat
%
% Output file restart flow
-RESTART_FLOW_FILENAME= Fluid/restart_flow.dat
+RESTART_FLOW_FILENAME= restart_flow.dat
%
% Output file convergence history (w/o extension)
-CONV_FILENAME= Fluid/history
+CONV_FILENAME= history
%
% Write binary restart files (YES, NO)
WRT_BINARY_RESTART= NO
@@ -226,10 +235,10 @@ WRT_BINARY_RESTART= NO
READ_BINARY_RESTART= NO
%
% Output file flow (w/o extension) variables
-VOLUME_FLOW_FILENAME= Fluid/flow
+VOLUME_FLOW_FILENAME= flow
%
% Output file surface flow coefficient (w/o extension)
-SURFACE_FLOW_FILENAME= Fluid/surface_flow
+SURFACE_FLOW_FILENAME= surface_flow
%
% Write surface solution files
WRT_SRF_SOL= NO
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/Fluid/fluidMesh.su2 b/perpendicular-flap/fluid-su2/fluidMesh.su2
similarity index 99%
rename from FSI/flap_perp_2D/SU2-FEniCS/Fluid/fluidMesh.su2
rename to perpendicular-flap/fluid-su2/fluidMesh.su2
index 8e203fcf4..3eb81ba50 100644
--- a/FSI/flap_perp_2D/SU2-FEniCS/Fluid/fluidMesh.su2
+++ b/perpendicular-flap/fluid-su2/fluidMesh.su2
@@ -1162,7 +1162,7 @@ MARKER_ELEMS= 24
3 58 59
3 59 60
3 60 5
-MARKER_TAG= wetSurface0
+MARKER_TAG= wetSurface
MARKER_ELEMS= 28
3 1 25
3 25 26
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/Fluid/initial_flow_00000.dat b/perpendicular-flap/fluid-su2/initial_flow_00000.dat
similarity index 100%
rename from FSI/flap_perp_2D/SU2-FEniCS/Fluid/initial_flow_00000.dat
rename to perpendicular-flap/fluid-su2/initial_flow_00000.dat
diff --git a/perpendicular-flap/fluid-su2/run.sh b/perpendicular-flap/fluid-su2/run.sh
new file mode 100755
index 000000000..a827818b5
--- /dev/null
+++ b/perpendicular-flap/fluid-su2/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+if [ "${1:-}" = "-parallel" ]; then
+ mpirun -n 2 SU2_CFD euler_config_coupled.cfg
+else
+ SU2_CFD euler_config_coupled.cfg
+fi
diff --git a/perpendicular-flap/images/tutorials-perpendicular-flap-displacement-all-watchpoints.png b/perpendicular-flap/images/tutorials-perpendicular-flap-displacement-all-watchpoints.png
new file mode 100644
index 000000000..26a1f1c4d
Binary files /dev/null and b/perpendicular-flap/images/tutorials-perpendicular-flap-displacement-all-watchpoints.png differ
diff --git a/perpendicular-flap/images/tutorials-perpendicular-flap-displacement-watchpoint.png b/perpendicular-flap/images/tutorials-perpendicular-flap-displacement-watchpoint.png
new file mode 100644
index 000000000..23128b6a8
Binary files /dev/null and b/perpendicular-flap/images/tutorials-perpendicular-flap-displacement-watchpoint.png differ
diff --git a/perpendicular-flap/images/tutorials-perpendicular-flap-physics.png b/perpendicular-flap/images/tutorials-perpendicular-flap-physics.png
new file mode 100644
index 000000000..ed2f9ed2e
Binary files /dev/null and b/perpendicular-flap/images/tutorials-perpendicular-flap-physics.png differ
diff --git a/perpendicular-flap/images/tutorials-perpendicular-flap-setup-drawing.png b/perpendicular-flap/images/tutorials-perpendicular-flap-setup-drawing.png
new file mode 100644
index 000000000..e3eeeddaf
Binary files /dev/null and b/perpendicular-flap/images/tutorials-perpendicular-flap-setup-drawing.png differ
diff --git a/perpendicular-flap/plot-all-displacements.sh b/perpendicular-flap/plot-all-displacements.sh
new file mode 100755
index 000000000..05ea08829
--- /dev/null
+++ b/perpendicular-flap/plot-all-displacements.sh
@@ -0,0 +1,15 @@
+#!/bin/sh
+
+gnuplot -p << EOF
+ set grid
+ set title 'x-displacement of the flap tip'
+ set xlabel 'time [s]'
+ set ylabel 'x-displacement [m]'
+ plot "watchpoints/openfoam-calculix.log" using 1:4 with lines title "OpenFOAM-CalculiX", \
+ "watchpoints/openfoam-dealii.log" using 1:4 with lines title "OpenFOAM-deal.II", \
+ "watchpoints/openfoam-fenics.log" using 1:4 with lines title "OpenFOAM-FEniCS", \
+ "watchpoints/su2-calculix.log" using 1:4 with lines title "SU2-CalculiX", \
+ "watchpoints/su2-dealii.log" using 1:4 with lines title "SU2-deal.II", \
+ "watchpoints/su2-fenics.log" using 1:4 with lines title "SU2-FEniCS", \
+ "watchpoints/nutils-dealii.log" using 1:4 with lines title "Nutils-deal.II"
+EOF
diff --git a/perpendicular-flap/plot-displacement.sh b/perpendicular-flap/plot-displacement.sh
new file mode 100755
index 000000000..0a81ccd59
--- /dev/null
+++ b/perpendicular-flap/plot-displacement.sh
@@ -0,0 +1,21 @@
+#!/bin/sh
+
+if [ "${1:-}" = "" ]; then
+ echo "No target directory specified. Please specify the directory of the solid participant containing the watchpoint, e.g. ./plot-displacement.sh solid-fenics."
+ exit 1
+fi
+
+FILE="$1/precice-Solid-watchpoint-Flap-Tip.log"
+
+if [ ! -f "$FILE" ]; then
+ echo "Unable to locate the watchpoint file (precice-Solid-watchpoint-Flap-Tip.log) in the specified solid directory '${1}'. Make sure the specified directory matches the solid participant you used for the calculations."
+ exit 1
+fi
+
+gnuplot -p << EOF
+ set grid
+ set title 'x-displacement of the flap tip'
+ set xlabel 'time [s]'
+ set ylabel 'x-displacement [m]'
+ plot "$1/precice-Solid-watchpoint-Flap-Tip.log" using 1:4 with lines title "$1"
+EOF
diff --git a/perpendicular-flap/precice-config.xml b/perpendicular-flap/precice-config.xml
new file mode 100644
index 000000000..97ebd5afc
--- /dev/null
+++ b/perpendicular-flap/precice-config.xml
@@ -0,0 +1,70 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/perpendicular-flap/solid-calculix/all.msh b/perpendicular-flap/solid-calculix/all.msh
new file mode 100644
index 000000000..5bfebc2b9
--- /dev/null
+++ b/perpendicular-flap/solid-calculix/all.msh
@@ -0,0 +1,984 @@
+*NODE, NSET=Nall
+ 1,5.000000000000e-02,0.000000000000e+00,1.000000000000e+00
+ 2,0.000000000000e+00,0.000000000000e+00,1.000000000000e+00
+ 3,0.000000000000e+00,8.196721311475e-03,1.000000000000e+00
+ 4,5.000000000000e-02,8.196721311475e-03,1.000000000000e+00
+ 5,5.000000000000e-02,0.000000000000e+00,0.000000000000e+00
+ 6,0.000000000000e+00,0.000000000000e+00,0.000000000000e+00
+ 7,0.000000000000e+00,8.196721311475e-03,0.000000000000e+00
+ 8,5.000000000000e-02,8.196721311475e-03,0.000000000000e+00
+ 9,0.000000000000e+00,1.639344262295e-02,1.000000000000e+00
+ 10,5.000000000000e-02,1.639344262295e-02,1.000000000000e+00
+ 11,0.000000000000e+00,1.639344262295e-02,0.000000000000e+00
+ 12,5.000000000000e-02,1.639344262295e-02,0.000000000000e+00
+ 13,0.000000000000e+00,2.459016393443e-02,1.000000000000e+00
+ 14,5.000000000000e-02,2.459016393443e-02,1.000000000000e+00
+ 15,0.000000000000e+00,2.459016393443e-02,0.000000000000e+00
+ 16,5.000000000000e-02,2.459016393443e-02,0.000000000000e+00
+ 17,0.000000000000e+00,3.278688524590e-02,1.000000000000e+00
+ 18,5.000000000000e-02,3.278688524590e-02,1.000000000000e+00
+ 19,0.000000000000e+00,3.278688524590e-02,0.000000000000e+00
+ 20,5.000000000000e-02,3.278688524590e-02,0.000000000000e+00
+ 21,0.000000000000e+00,4.098360655738e-02,1.000000000000e+00
+ 22,5.000000000000e-02,4.098360655738e-02,1.000000000000e+00
+ 23,0.000000000000e+00,4.098360655738e-02,0.000000000000e+00
+ 24,5.000000000000e-02,4.098360655738e-02,0.000000000000e+00
+ 25,0.000000000000e+00,4.918032786885e-02,1.000000000000e+00
+ 26,5.000000000000e-02,4.918032786885e-02,1.000000000000e+00
+ 27,0.000000000000e+00,4.918032786885e-02,0.000000000000e+00
+ 28,5.000000000000e-02,4.918032786885e-02,0.000000000000e+00
+ 29,0.000000000000e+00,5.737704918033e-02,1.000000000000e+00
+ 30,5.000000000000e-02,5.737704918033e-02,1.000000000000e+00
+ 31,0.000000000000e+00,5.737704918033e-02,0.000000000000e+00
+ 32,5.000000000000e-02,5.737704918033e-02,0.000000000000e+00
+ 33,0.000000000000e+00,6.557377049180e-02,1.000000000000e+00
+ 34,5.000000000000e-02,6.557377049180e-02,1.000000000000e+00
+ 35,0.000000000000e+00,6.557377049180e-02,0.000000000000e+00
+ 36,5.000000000000e-02,6.557377049180e-02,0.000000000000e+00
+ 37,0.000000000000e+00,7.377049180328e-02,1.000000000000e+00
+ 38,5.000000000000e-02,7.377049180328e-02,1.000000000000e+00
+ 39,0.000000000000e+00,7.377049180328e-02,0.000000000000e+00
+ 40,5.000000000000e-02,7.377049180328e-02,0.000000000000e+00
+ 41,0.000000000000e+00,8.196721311475e-02,1.000000000000e+00
+ 42,5.000000000000e-02,8.196721311475e-02,1.000000000000e+00
+ 43,0.000000000000e+00,8.196721311475e-02,0.000000000000e+00
+ 44,5.000000000000e-02,8.196721311475e-02,0.000000000000e+00
+ 45,0.000000000000e+00,9.016393442623e-02,1.000000000000e+00
+ 46,5.000000000000e-02,9.016393442623e-02,1.000000000000e+00
+ 47,0.000000000000e+00,9.016393442623e-02,0.000000000000e+00
+ 48,5.000000000000e-02,9.016393442623e-02,0.000000000000e+00
+ 49,0.000000000000e+00,9.836065573770e-02,1.000000000000e+00
+ 50,5.000000000000e-02,9.836065573770e-02,1.000000000000e+00
+ 51,0.000000000000e+00,9.836065573770e-02,0.000000000000e+00
+ 52,5.000000000000e-02,9.836065573770e-02,0.000000000000e+00
+ 53,0.000000000000e+00,1.065573770492e-01,1.000000000000e+00
+ 54,5.000000000000e-02,1.065573770492e-01,1.000000000000e+00
+ 55,0.000000000000e+00,1.065573770492e-01,0.000000000000e+00
+ 56,5.000000000000e-02,1.065573770492e-01,0.000000000000e+00
+ 57,0.000000000000e+00,1.147540983607e-01,1.000000000000e+00
+ 58,5.000000000000e-02,1.147540983607e-01,1.000000000000e+00
+ 59,0.000000000000e+00,1.147540983607e-01,0.000000000000e+00
+ 60,5.000000000000e-02,1.147540983607e-01,0.000000000000e+00
+ 61,0.000000000000e+00,1.229508196721e-01,1.000000000000e+00
+ 62,5.000000000000e-02,1.229508196721e-01,1.000000000000e+00
+ 63,0.000000000000e+00,1.229508196721e-01,0.000000000000e+00
+ 64,5.000000000000e-02,1.229508196721e-01,0.000000000000e+00
+ 65,0.000000000000e+00,1.311475409836e-01,1.000000000000e+00
+ 66,5.000000000000e-02,1.311475409836e-01,1.000000000000e+00
+ 67,0.000000000000e+00,1.311475409836e-01,0.000000000000e+00
+ 68,5.000000000000e-02,1.311475409836e-01,0.000000000000e+00
+ 69,0.000000000000e+00,1.393442622951e-01,1.000000000000e+00
+ 70,5.000000000000e-02,1.393442622951e-01,1.000000000000e+00
+ 71,0.000000000000e+00,1.393442622951e-01,0.000000000000e+00
+ 72,5.000000000000e-02,1.393442622951e-01,0.000000000000e+00
+ 73,0.000000000000e+00,1.475409836066e-01,1.000000000000e+00
+ 74,5.000000000000e-02,1.475409836066e-01,1.000000000000e+00
+ 75,0.000000000000e+00,1.475409836066e-01,0.000000000000e+00
+ 76,5.000000000000e-02,1.475409836066e-01,0.000000000000e+00
+ 77,0.000000000000e+00,1.557377049180e-01,1.000000000000e+00
+ 78,5.000000000000e-02,1.557377049180e-01,1.000000000000e+00
+ 79,0.000000000000e+00,1.557377049180e-01,0.000000000000e+00
+ 80,5.000000000000e-02,1.557377049180e-01,0.000000000000e+00
+ 81,0.000000000000e+00,1.639344262295e-01,1.000000000000e+00
+ 82,5.000000000000e-02,1.639344262295e-01,1.000000000000e+00
+ 83,0.000000000000e+00,1.639344262295e-01,0.000000000000e+00
+ 84,5.000000000000e-02,1.639344262295e-01,0.000000000000e+00
+ 85,0.000000000000e+00,1.721311475410e-01,1.000000000000e+00
+ 86,5.000000000000e-02,1.721311475410e-01,1.000000000000e+00
+ 87,0.000000000000e+00,1.721311475410e-01,0.000000000000e+00
+ 88,5.000000000000e-02,1.721311475410e-01,0.000000000000e+00
+ 89,0.000000000000e+00,1.803278688525e-01,1.000000000000e+00
+ 90,5.000000000000e-02,1.803278688525e-01,1.000000000000e+00
+ 91,0.000000000000e+00,1.803278688525e-01,0.000000000000e+00
+ 92,5.000000000000e-02,1.803278688525e-01,0.000000000000e+00
+ 93,0.000000000000e+00,1.885245901639e-01,1.000000000000e+00
+ 94,5.000000000000e-02,1.885245901639e-01,1.000000000000e+00
+ 95,0.000000000000e+00,1.885245901639e-01,0.000000000000e+00
+ 96,5.000000000000e-02,1.885245901639e-01,0.000000000000e+00
+ 97,0.000000000000e+00,1.967213114754e-01,1.000000000000e+00
+ 98,5.000000000000e-02,1.967213114754e-01,1.000000000000e+00
+ 99,0.000000000000e+00,1.967213114754e-01,0.000000000000e+00
+ 100,5.000000000000e-02,1.967213114754e-01,0.000000000000e+00
+ 101,0.000000000000e+00,2.049180327869e-01,1.000000000000e+00
+ 102,5.000000000000e-02,2.049180327869e-01,1.000000000000e+00
+ 103,0.000000000000e+00,2.049180327869e-01,0.000000000000e+00
+ 104,5.000000000000e-02,2.049180327869e-01,0.000000000000e+00
+ 105,0.000000000000e+00,2.131147540984e-01,1.000000000000e+00
+ 106,5.000000000000e-02,2.131147540984e-01,1.000000000000e+00
+ 107,0.000000000000e+00,2.131147540984e-01,0.000000000000e+00
+ 108,5.000000000000e-02,2.131147540984e-01,0.000000000000e+00
+ 109,0.000000000000e+00,2.213114754098e-01,1.000000000000e+00
+ 110,5.000000000000e-02,2.213114754098e-01,1.000000000000e+00
+ 111,0.000000000000e+00,2.213114754098e-01,0.000000000000e+00
+ 112,5.000000000000e-02,2.213114754098e-01,0.000000000000e+00
+ 113,0.000000000000e+00,2.295081967213e-01,1.000000000000e+00
+ 114,5.000000000000e-02,2.295081967213e-01,1.000000000000e+00
+ 115,0.000000000000e+00,2.295081967213e-01,0.000000000000e+00
+ 116,5.000000000000e-02,2.295081967213e-01,0.000000000000e+00
+ 117,0.000000000000e+00,2.377049180328e-01,1.000000000000e+00
+ 118,5.000000000000e-02,2.377049180328e-01,1.000000000000e+00
+ 119,0.000000000000e+00,2.377049180328e-01,0.000000000000e+00
+ 120,5.000000000000e-02,2.377049180328e-01,0.000000000000e+00
+ 121,0.000000000000e+00,2.459016393443e-01,1.000000000000e+00
+ 122,5.000000000000e-02,2.459016393443e-01,1.000000000000e+00
+ 123,0.000000000000e+00,2.459016393443e-01,0.000000000000e+00
+ 124,5.000000000000e-02,2.459016393443e-01,0.000000000000e+00
+ 125,0.000000000000e+00,2.540983606557e-01,1.000000000000e+00
+ 126,5.000000000000e-02,2.540983606557e-01,1.000000000000e+00
+ 127,0.000000000000e+00,2.540983606557e-01,0.000000000000e+00
+ 128,5.000000000000e-02,2.540983606557e-01,0.000000000000e+00
+ 129,0.000000000000e+00,2.622950819672e-01,1.000000000000e+00
+ 130,5.000000000000e-02,2.622950819672e-01,1.000000000000e+00
+ 131,0.000000000000e+00,2.622950819672e-01,0.000000000000e+00
+ 132,5.000000000000e-02,2.622950819672e-01,0.000000000000e+00
+ 133,0.000000000000e+00,2.704918032787e-01,1.000000000000e+00
+ 134,5.000000000000e-02,2.704918032787e-01,1.000000000000e+00
+ 135,0.000000000000e+00,2.704918032787e-01,0.000000000000e+00
+ 136,5.000000000000e-02,2.704918032787e-01,0.000000000000e+00
+ 137,0.000000000000e+00,2.786885245902e-01,1.000000000000e+00
+ 138,5.000000000000e-02,2.786885245902e-01,1.000000000000e+00
+ 139,0.000000000000e+00,2.786885245902e-01,0.000000000000e+00
+ 140,5.000000000000e-02,2.786885245902e-01,0.000000000000e+00
+ 141,0.000000000000e+00,2.868852459016e-01,1.000000000000e+00
+ 142,5.000000000000e-02,2.868852459016e-01,1.000000000000e+00
+ 143,0.000000000000e+00,2.868852459016e-01,0.000000000000e+00
+ 144,5.000000000000e-02,2.868852459016e-01,0.000000000000e+00
+ 145,0.000000000000e+00,2.950819672131e-01,1.000000000000e+00
+ 146,5.000000000000e-02,2.950819672131e-01,1.000000000000e+00
+ 147,0.000000000000e+00,2.950819672131e-01,0.000000000000e+00
+ 148,5.000000000000e-02,2.950819672131e-01,0.000000000000e+00
+ 149,0.000000000000e+00,3.032786885246e-01,1.000000000000e+00
+ 150,5.000000000000e-02,3.032786885246e-01,1.000000000000e+00
+ 151,0.000000000000e+00,3.032786885246e-01,0.000000000000e+00
+ 152,5.000000000000e-02,3.032786885246e-01,0.000000000000e+00
+ 153,0.000000000000e+00,3.114754098361e-01,1.000000000000e+00
+ 154,5.000000000000e-02,3.114754098361e-01,1.000000000000e+00
+ 155,0.000000000000e+00,3.114754098361e-01,0.000000000000e+00
+ 156,5.000000000000e-02,3.114754098361e-01,0.000000000000e+00
+ 157,0.000000000000e+00,3.196721311475e-01,1.000000000000e+00
+ 158,5.000000000000e-02,3.196721311475e-01,1.000000000000e+00
+ 159,0.000000000000e+00,3.196721311475e-01,0.000000000000e+00
+ 160,5.000000000000e-02,3.196721311475e-01,0.000000000000e+00
+ 161,0.000000000000e+00,3.278688524590e-01,1.000000000000e+00
+ 162,5.000000000000e-02,3.278688524590e-01,1.000000000000e+00
+ 163,0.000000000000e+00,3.278688524590e-01,0.000000000000e+00
+ 164,5.000000000000e-02,3.278688524590e-01,0.000000000000e+00
+ 165,0.000000000000e+00,3.360655737705e-01,1.000000000000e+00
+ 166,5.000000000000e-02,3.360655737705e-01,1.000000000000e+00
+ 167,0.000000000000e+00,3.360655737705e-01,0.000000000000e+00
+ 168,5.000000000000e-02,3.360655737705e-01,0.000000000000e+00
+ 169,0.000000000000e+00,3.442622950820e-01,1.000000000000e+00
+ 170,5.000000000000e-02,3.442622950820e-01,1.000000000000e+00
+ 171,0.000000000000e+00,3.442622950820e-01,0.000000000000e+00
+ 172,5.000000000000e-02,3.442622950820e-01,0.000000000000e+00
+ 173,0.000000000000e+00,3.524590163934e-01,1.000000000000e+00
+ 174,5.000000000000e-02,3.524590163934e-01,1.000000000000e+00
+ 175,0.000000000000e+00,3.524590163934e-01,0.000000000000e+00
+ 176,5.000000000000e-02,3.524590163934e-01,0.000000000000e+00
+ 177,0.000000000000e+00,3.606557377049e-01,1.000000000000e+00
+ 178,5.000000000000e-02,3.606557377049e-01,1.000000000000e+00
+ 179,0.000000000000e+00,3.606557377049e-01,0.000000000000e+00
+ 180,5.000000000000e-02,3.606557377049e-01,0.000000000000e+00
+ 181,0.000000000000e+00,3.688524590164e-01,1.000000000000e+00
+ 182,5.000000000000e-02,3.688524590164e-01,1.000000000000e+00
+ 183,0.000000000000e+00,3.688524590164e-01,0.000000000000e+00
+ 184,5.000000000000e-02,3.688524590164e-01,0.000000000000e+00
+ 185,0.000000000000e+00,3.770491803279e-01,1.000000000000e+00
+ 186,5.000000000000e-02,3.770491803279e-01,1.000000000000e+00
+ 187,0.000000000000e+00,3.770491803279e-01,0.000000000000e+00
+ 188,5.000000000000e-02,3.770491803279e-01,0.000000000000e+00
+ 189,0.000000000000e+00,3.852459016393e-01,1.000000000000e+00
+ 190,5.000000000000e-02,3.852459016393e-01,1.000000000000e+00
+ 191,0.000000000000e+00,3.852459016393e-01,0.000000000000e+00
+ 192,5.000000000000e-02,3.852459016393e-01,0.000000000000e+00
+ 193,0.000000000000e+00,3.934426229508e-01,1.000000000000e+00
+ 194,5.000000000000e-02,3.934426229508e-01,1.000000000000e+00
+ 195,0.000000000000e+00,3.934426229508e-01,0.000000000000e+00
+ 196,5.000000000000e-02,3.934426229508e-01,0.000000000000e+00
+ 197,0.000000000000e+00,4.016393442623e-01,1.000000000000e+00
+ 198,5.000000000000e-02,4.016393442623e-01,1.000000000000e+00
+ 199,0.000000000000e+00,4.016393442623e-01,0.000000000000e+00
+ 200,5.000000000000e-02,4.016393442623e-01,0.000000000000e+00
+ 201,0.000000000000e+00,4.098360655738e-01,1.000000000000e+00
+ 202,5.000000000000e-02,4.098360655738e-01,1.000000000000e+00
+ 203,0.000000000000e+00,4.098360655738e-01,0.000000000000e+00
+ 204,5.000000000000e-02,4.098360655738e-01,0.000000000000e+00
+ 205,0.000000000000e+00,4.180327868852e-01,1.000000000000e+00
+ 206,5.000000000000e-02,4.180327868852e-01,1.000000000000e+00
+ 207,0.000000000000e+00,4.180327868852e-01,0.000000000000e+00
+ 208,5.000000000000e-02,4.180327868852e-01,0.000000000000e+00
+ 209,0.000000000000e+00,4.262295081967e-01,1.000000000000e+00
+ 210,5.000000000000e-02,4.262295081967e-01,1.000000000000e+00
+ 211,0.000000000000e+00,4.262295081967e-01,0.000000000000e+00
+ 212,5.000000000000e-02,4.262295081967e-01,0.000000000000e+00
+ 213,0.000000000000e+00,4.344262295082e-01,1.000000000000e+00
+ 214,5.000000000000e-02,4.344262295082e-01,1.000000000000e+00
+ 215,0.000000000000e+00,4.344262295082e-01,0.000000000000e+00
+ 216,5.000000000000e-02,4.344262295082e-01,0.000000000000e+00
+ 217,0.000000000000e+00,4.426229508197e-01,1.000000000000e+00
+ 218,5.000000000000e-02,4.426229508197e-01,1.000000000000e+00
+ 219,0.000000000000e+00,4.426229508197e-01,0.000000000000e+00
+ 220,5.000000000000e-02,4.426229508197e-01,0.000000000000e+00
+ 221,0.000000000000e+00,4.508196721311e-01,1.000000000000e+00
+ 222,5.000000000000e-02,4.508196721311e-01,1.000000000000e+00
+ 223,0.000000000000e+00,4.508196721311e-01,0.000000000000e+00
+ 224,5.000000000000e-02,4.508196721311e-01,0.000000000000e+00
+ 225,0.000000000000e+00,4.590163934426e-01,1.000000000000e+00
+ 226,5.000000000000e-02,4.590163934426e-01,1.000000000000e+00
+ 227,0.000000000000e+00,4.590163934426e-01,0.000000000000e+00
+ 228,5.000000000000e-02,4.590163934426e-01,0.000000000000e+00
+ 229,0.000000000000e+00,4.672131147541e-01,1.000000000000e+00
+ 230,5.000000000000e-02,4.672131147541e-01,1.000000000000e+00
+ 231,0.000000000000e+00,4.672131147541e-01,0.000000000000e+00
+ 232,5.000000000000e-02,4.672131147541e-01,0.000000000000e+00
+ 233,0.000000000000e+00,4.754098360656e-01,1.000000000000e+00
+ 234,5.000000000000e-02,4.754098360656e-01,1.000000000000e+00
+ 235,0.000000000000e+00,4.754098360656e-01,0.000000000000e+00
+ 236,5.000000000000e-02,4.754098360656e-01,0.000000000000e+00
+ 237,0.000000000000e+00,4.836065573770e-01,1.000000000000e+00
+ 238,5.000000000000e-02,4.836065573770e-01,1.000000000000e+00
+ 239,0.000000000000e+00,4.836065573770e-01,0.000000000000e+00
+ 240,5.000000000000e-02,4.836065573770e-01,0.000000000000e+00
+ 241,0.000000000000e+00,4.918032786885e-01,1.000000000000e+00
+ 242,5.000000000000e-02,4.918032786885e-01,1.000000000000e+00
+ 243,0.000000000000e+00,4.918032786885e-01,0.000000000000e+00
+ 244,5.000000000000e-02,4.918032786885e-01,0.000000000000e+00
+ 245,0.000000000000e+00,5.000000000000e-01,1.000000000000e+00
+ 246,5.000000000000e-02,5.000000000000e-01,1.000000000000e+00
+ 247,0.000000000000e+00,5.000000000000e-01,0.000000000000e+00
+ 248,5.000000000000e-02,5.000000000000e-01,0.000000000000e+00
+ 249,0.000000000000e+00,5.081967213115e-01,1.000000000000e+00
+ 250,5.000000000000e-02,5.081967213115e-01,1.000000000000e+00
+ 251,0.000000000000e+00,5.081967213115e-01,0.000000000000e+00
+ 252,5.000000000000e-02,5.081967213115e-01,0.000000000000e+00
+ 253,0.000000000000e+00,5.163934426230e-01,1.000000000000e+00
+ 254,5.000000000000e-02,5.163934426230e-01,1.000000000000e+00
+ 255,0.000000000000e+00,5.163934426230e-01,0.000000000000e+00
+ 256,5.000000000000e-02,5.163934426230e-01,0.000000000000e+00
+ 257,0.000000000000e+00,5.245901639344e-01,1.000000000000e+00
+ 258,5.000000000000e-02,5.245901639344e-01,1.000000000000e+00
+ 259,0.000000000000e+00,5.245901639344e-01,0.000000000000e+00
+ 260,5.000000000000e-02,5.245901639344e-01,0.000000000000e+00
+ 261,0.000000000000e+00,5.327868852459e-01,1.000000000000e+00
+ 262,5.000000000000e-02,5.327868852459e-01,1.000000000000e+00
+ 263,0.000000000000e+00,5.327868852459e-01,0.000000000000e+00
+ 264,5.000000000000e-02,5.327868852459e-01,0.000000000000e+00
+ 265,0.000000000000e+00,5.409836065574e-01,1.000000000000e+00
+ 266,5.000000000000e-02,5.409836065574e-01,1.000000000000e+00
+ 267,0.000000000000e+00,5.409836065574e-01,0.000000000000e+00
+ 268,5.000000000000e-02,5.409836065574e-01,0.000000000000e+00
+ 269,0.000000000000e+00,5.491803278689e-01,1.000000000000e+00
+ 270,5.000000000000e-02,5.491803278689e-01,1.000000000000e+00
+ 271,0.000000000000e+00,5.491803278689e-01,0.000000000000e+00
+ 272,5.000000000000e-02,5.491803278689e-01,0.000000000000e+00
+ 273,0.000000000000e+00,5.573770491803e-01,1.000000000000e+00
+ 274,5.000000000000e-02,5.573770491803e-01,1.000000000000e+00
+ 275,0.000000000000e+00,5.573770491803e-01,0.000000000000e+00
+ 276,5.000000000000e-02,5.573770491803e-01,0.000000000000e+00
+ 277,0.000000000000e+00,5.655737704918e-01,1.000000000000e+00
+ 278,5.000000000000e-02,5.655737704918e-01,1.000000000000e+00
+ 279,0.000000000000e+00,5.655737704918e-01,0.000000000000e+00
+ 280,5.000000000000e-02,5.655737704918e-01,0.000000000000e+00
+ 281,0.000000000000e+00,5.737704918033e-01,1.000000000000e+00
+ 282,5.000000000000e-02,5.737704918033e-01,1.000000000000e+00
+ 283,0.000000000000e+00,5.737704918033e-01,0.000000000000e+00
+ 284,5.000000000000e-02,5.737704918033e-01,0.000000000000e+00
+ 285,0.000000000000e+00,5.819672131148e-01,1.000000000000e+00
+ 286,5.000000000000e-02,5.819672131148e-01,1.000000000000e+00
+ 287,0.000000000000e+00,5.819672131148e-01,0.000000000000e+00
+ 288,5.000000000000e-02,5.819672131148e-01,0.000000000000e+00
+ 289,0.000000000000e+00,5.901639344262e-01,1.000000000000e+00
+ 290,5.000000000000e-02,5.901639344262e-01,1.000000000000e+00
+ 291,0.000000000000e+00,5.901639344262e-01,0.000000000000e+00
+ 292,5.000000000000e-02,5.901639344262e-01,0.000000000000e+00
+ 293,0.000000000000e+00,5.983606557377e-01,1.000000000000e+00
+ 294,5.000000000000e-02,5.983606557377e-01,1.000000000000e+00
+ 295,0.000000000000e+00,5.983606557377e-01,0.000000000000e+00
+ 296,5.000000000000e-02,5.983606557377e-01,0.000000000000e+00
+ 297,0.000000000000e+00,6.065573770492e-01,1.000000000000e+00
+ 298,5.000000000000e-02,6.065573770492e-01,1.000000000000e+00
+ 299,0.000000000000e+00,6.065573770492e-01,0.000000000000e+00
+ 300,5.000000000000e-02,6.065573770492e-01,0.000000000000e+00
+ 301,0.000000000000e+00,6.147540983607e-01,1.000000000000e+00
+ 302,5.000000000000e-02,6.147540983607e-01,1.000000000000e+00
+ 303,0.000000000000e+00,6.147540983607e-01,0.000000000000e+00
+ 304,5.000000000000e-02,6.147540983607e-01,0.000000000000e+00
+ 305,0.000000000000e+00,6.229508196721e-01,1.000000000000e+00
+ 306,5.000000000000e-02,6.229508196721e-01,1.000000000000e+00
+ 307,0.000000000000e+00,6.229508196721e-01,0.000000000000e+00
+ 308,5.000000000000e-02,6.229508196721e-01,0.000000000000e+00
+ 309,0.000000000000e+00,6.311475409836e-01,1.000000000000e+00
+ 310,5.000000000000e-02,6.311475409836e-01,1.000000000000e+00
+ 311,0.000000000000e+00,6.311475409836e-01,0.000000000000e+00
+ 312,5.000000000000e-02,6.311475409836e-01,0.000000000000e+00
+ 313,0.000000000000e+00,6.393442622951e-01,1.000000000000e+00
+ 314,5.000000000000e-02,6.393442622951e-01,1.000000000000e+00
+ 315,0.000000000000e+00,6.393442622951e-01,0.000000000000e+00
+ 316,5.000000000000e-02,6.393442622951e-01,0.000000000000e+00
+ 317,0.000000000000e+00,6.475409836066e-01,1.000000000000e+00
+ 318,5.000000000000e-02,6.475409836066e-01,1.000000000000e+00
+ 319,0.000000000000e+00,6.475409836066e-01,0.000000000000e+00
+ 320,5.000000000000e-02,6.475409836066e-01,0.000000000000e+00
+ 321,0.000000000000e+00,6.557377049180e-01,1.000000000000e+00
+ 322,5.000000000000e-02,6.557377049180e-01,1.000000000000e+00
+ 323,0.000000000000e+00,6.557377049180e-01,0.000000000000e+00
+ 324,5.000000000000e-02,6.557377049180e-01,0.000000000000e+00
+ 325,0.000000000000e+00,6.639344262295e-01,1.000000000000e+00
+ 326,5.000000000000e-02,6.639344262295e-01,1.000000000000e+00
+ 327,0.000000000000e+00,6.639344262295e-01,0.000000000000e+00
+ 328,5.000000000000e-02,6.639344262295e-01,0.000000000000e+00
+ 329,0.000000000000e+00,6.721311475410e-01,1.000000000000e+00
+ 330,5.000000000000e-02,6.721311475410e-01,1.000000000000e+00
+ 331,0.000000000000e+00,6.721311475410e-01,0.000000000000e+00
+ 332,5.000000000000e-02,6.721311475410e-01,0.000000000000e+00
+ 333,0.000000000000e+00,6.803278688525e-01,1.000000000000e+00
+ 334,5.000000000000e-02,6.803278688525e-01,1.000000000000e+00
+ 335,0.000000000000e+00,6.803278688525e-01,0.000000000000e+00
+ 336,5.000000000000e-02,6.803278688525e-01,0.000000000000e+00
+ 337,0.000000000000e+00,6.885245901639e-01,1.000000000000e+00
+ 338,5.000000000000e-02,6.885245901639e-01,1.000000000000e+00
+ 339,0.000000000000e+00,6.885245901639e-01,0.000000000000e+00
+ 340,5.000000000000e-02,6.885245901639e-01,0.000000000000e+00
+ 341,0.000000000000e+00,6.967213114754e-01,1.000000000000e+00
+ 342,5.000000000000e-02,6.967213114754e-01,1.000000000000e+00
+ 343,0.000000000000e+00,6.967213114754e-01,0.000000000000e+00
+ 344,5.000000000000e-02,6.967213114754e-01,0.000000000000e+00
+ 345,0.000000000000e+00,7.049180327869e-01,1.000000000000e+00
+ 346,5.000000000000e-02,7.049180327869e-01,1.000000000000e+00
+ 347,0.000000000000e+00,7.049180327869e-01,0.000000000000e+00
+ 348,5.000000000000e-02,7.049180327869e-01,0.000000000000e+00
+ 349,0.000000000000e+00,7.131147540984e-01,1.000000000000e+00
+ 350,5.000000000000e-02,7.131147540984e-01,1.000000000000e+00
+ 351,0.000000000000e+00,7.131147540984e-01,0.000000000000e+00
+ 352,5.000000000000e-02,7.131147540984e-01,0.000000000000e+00
+ 353,0.000000000000e+00,7.213114754098e-01,1.000000000000e+00
+ 354,5.000000000000e-02,7.213114754098e-01,1.000000000000e+00
+ 355,0.000000000000e+00,7.213114754098e-01,0.000000000000e+00
+ 356,5.000000000000e-02,7.213114754098e-01,0.000000000000e+00
+ 357,0.000000000000e+00,7.295081967213e-01,1.000000000000e+00
+ 358,5.000000000000e-02,7.295081967213e-01,1.000000000000e+00
+ 359,0.000000000000e+00,7.295081967213e-01,0.000000000000e+00
+ 360,5.000000000000e-02,7.295081967213e-01,0.000000000000e+00
+ 361,0.000000000000e+00,7.377049180328e-01,1.000000000000e+00
+ 362,5.000000000000e-02,7.377049180328e-01,1.000000000000e+00
+ 363,0.000000000000e+00,7.377049180328e-01,0.000000000000e+00
+ 364,5.000000000000e-02,7.377049180328e-01,0.000000000000e+00
+ 365,0.000000000000e+00,7.459016393443e-01,1.000000000000e+00
+ 366,5.000000000000e-02,7.459016393443e-01,1.000000000000e+00
+ 367,0.000000000000e+00,7.459016393443e-01,0.000000000000e+00
+ 368,5.000000000000e-02,7.459016393443e-01,0.000000000000e+00
+ 369,0.000000000000e+00,7.540983606557e-01,1.000000000000e+00
+ 370,5.000000000000e-02,7.540983606557e-01,1.000000000000e+00
+ 371,0.000000000000e+00,7.540983606557e-01,0.000000000000e+00
+ 372,5.000000000000e-02,7.540983606557e-01,0.000000000000e+00
+ 373,0.000000000000e+00,7.622950819672e-01,1.000000000000e+00
+ 374,5.000000000000e-02,7.622950819672e-01,1.000000000000e+00
+ 375,0.000000000000e+00,7.622950819672e-01,0.000000000000e+00
+ 376,5.000000000000e-02,7.622950819672e-01,0.000000000000e+00
+ 377,0.000000000000e+00,7.704918032787e-01,1.000000000000e+00
+ 378,5.000000000000e-02,7.704918032787e-01,1.000000000000e+00
+ 379,0.000000000000e+00,7.704918032787e-01,0.000000000000e+00
+ 380,5.000000000000e-02,7.704918032787e-01,0.000000000000e+00
+ 381,0.000000000000e+00,7.786885245902e-01,1.000000000000e+00
+ 382,5.000000000000e-02,7.786885245902e-01,1.000000000000e+00
+ 383,0.000000000000e+00,7.786885245902e-01,0.000000000000e+00
+ 384,5.000000000000e-02,7.786885245902e-01,0.000000000000e+00
+ 385,0.000000000000e+00,7.868852459016e-01,1.000000000000e+00
+ 386,5.000000000000e-02,7.868852459016e-01,1.000000000000e+00
+ 387,0.000000000000e+00,7.868852459016e-01,0.000000000000e+00
+ 388,5.000000000000e-02,7.868852459016e-01,0.000000000000e+00
+ 389,0.000000000000e+00,7.950819672131e-01,1.000000000000e+00
+ 390,5.000000000000e-02,7.950819672131e-01,1.000000000000e+00
+ 391,0.000000000000e+00,7.950819672131e-01,0.000000000000e+00
+ 392,5.000000000000e-02,7.950819672131e-01,0.000000000000e+00
+ 393,0.000000000000e+00,8.032786885246e-01,1.000000000000e+00
+ 394,5.000000000000e-02,8.032786885246e-01,1.000000000000e+00
+ 395,0.000000000000e+00,8.032786885246e-01,0.000000000000e+00
+ 396,5.000000000000e-02,8.032786885246e-01,0.000000000000e+00
+ 397,0.000000000000e+00,8.114754098361e-01,1.000000000000e+00
+ 398,5.000000000000e-02,8.114754098361e-01,1.000000000000e+00
+ 399,0.000000000000e+00,8.114754098361e-01,0.000000000000e+00
+ 400,5.000000000000e-02,8.114754098361e-01,0.000000000000e+00
+ 401,0.000000000000e+00,8.196721311475e-01,1.000000000000e+00
+ 402,5.000000000000e-02,8.196721311475e-01,1.000000000000e+00
+ 403,0.000000000000e+00,8.196721311475e-01,0.000000000000e+00
+ 404,5.000000000000e-02,8.196721311475e-01,0.000000000000e+00
+ 405,0.000000000000e+00,8.278688524590e-01,1.000000000000e+00
+ 406,5.000000000000e-02,8.278688524590e-01,1.000000000000e+00
+ 407,0.000000000000e+00,8.278688524590e-01,0.000000000000e+00
+ 408,5.000000000000e-02,8.278688524590e-01,0.000000000000e+00
+ 409,0.000000000000e+00,8.360655737705e-01,1.000000000000e+00
+ 410,5.000000000000e-02,8.360655737705e-01,1.000000000000e+00
+ 411,0.000000000000e+00,8.360655737705e-01,0.000000000000e+00
+ 412,5.000000000000e-02,8.360655737705e-01,0.000000000000e+00
+ 413,0.000000000000e+00,8.442622950820e-01,1.000000000000e+00
+ 414,5.000000000000e-02,8.442622950820e-01,1.000000000000e+00
+ 415,0.000000000000e+00,8.442622950820e-01,0.000000000000e+00
+ 416,5.000000000000e-02,8.442622950820e-01,0.000000000000e+00
+ 417,0.000000000000e+00,8.524590163934e-01,1.000000000000e+00
+ 418,5.000000000000e-02,8.524590163934e-01,1.000000000000e+00
+ 419,0.000000000000e+00,8.524590163934e-01,0.000000000000e+00
+ 420,5.000000000000e-02,8.524590163934e-01,0.000000000000e+00
+ 421,0.000000000000e+00,8.606557377049e-01,1.000000000000e+00
+ 422,5.000000000000e-02,8.606557377049e-01,1.000000000000e+00
+ 423,0.000000000000e+00,8.606557377049e-01,0.000000000000e+00
+ 424,5.000000000000e-02,8.606557377049e-01,0.000000000000e+00
+ 425,0.000000000000e+00,8.688524590164e-01,1.000000000000e+00
+ 426,5.000000000000e-02,8.688524590164e-01,1.000000000000e+00
+ 427,0.000000000000e+00,8.688524590164e-01,0.000000000000e+00
+ 428,5.000000000000e-02,8.688524590164e-01,0.000000000000e+00
+ 429,0.000000000000e+00,8.770491803279e-01,1.000000000000e+00
+ 430,5.000000000000e-02,8.770491803279e-01,1.000000000000e+00
+ 431,0.000000000000e+00,8.770491803279e-01,0.000000000000e+00
+ 432,5.000000000000e-02,8.770491803279e-01,0.000000000000e+00
+ 433,0.000000000000e+00,8.852459016393e-01,1.000000000000e+00
+ 434,5.000000000000e-02,8.852459016393e-01,1.000000000000e+00
+ 435,0.000000000000e+00,8.852459016393e-01,0.000000000000e+00
+ 436,5.000000000000e-02,8.852459016393e-01,0.000000000000e+00
+ 437,0.000000000000e+00,8.934426229508e-01,1.000000000000e+00
+ 438,5.000000000000e-02,8.934426229508e-01,1.000000000000e+00
+ 439,0.000000000000e+00,8.934426229508e-01,0.000000000000e+00
+ 440,5.000000000000e-02,8.934426229508e-01,0.000000000000e+00
+ 441,0.000000000000e+00,9.016393442623e-01,1.000000000000e+00
+ 442,5.000000000000e-02,9.016393442623e-01,1.000000000000e+00
+ 443,0.000000000000e+00,9.016393442623e-01,0.000000000000e+00
+ 444,5.000000000000e-02,9.016393442623e-01,0.000000000000e+00
+ 445,0.000000000000e+00,9.098360655738e-01,1.000000000000e+00
+ 446,5.000000000000e-02,9.098360655738e-01,1.000000000000e+00
+ 447,0.000000000000e+00,9.098360655738e-01,0.000000000000e+00
+ 448,5.000000000000e-02,9.098360655738e-01,0.000000000000e+00
+ 449,0.000000000000e+00,9.180327868852e-01,1.000000000000e+00
+ 450,5.000000000000e-02,9.180327868852e-01,1.000000000000e+00
+ 451,0.000000000000e+00,9.180327868852e-01,0.000000000000e+00
+ 452,5.000000000000e-02,9.180327868852e-01,0.000000000000e+00
+ 453,0.000000000000e+00,9.262295081967e-01,1.000000000000e+00
+ 454,5.000000000000e-02,9.262295081967e-01,1.000000000000e+00
+ 455,0.000000000000e+00,9.262295081967e-01,0.000000000000e+00
+ 456,5.000000000000e-02,9.262295081967e-01,0.000000000000e+00
+ 457,0.000000000000e+00,9.344262295082e-01,1.000000000000e+00
+ 458,5.000000000000e-02,9.344262295082e-01,1.000000000000e+00
+ 459,0.000000000000e+00,9.344262295082e-01,0.000000000000e+00
+ 460,5.000000000000e-02,9.344262295082e-01,0.000000000000e+00
+ 461,0.000000000000e+00,9.426229508197e-01,1.000000000000e+00
+ 462,5.000000000000e-02,9.426229508197e-01,1.000000000000e+00
+ 463,0.000000000000e+00,9.426229508197e-01,0.000000000000e+00
+ 464,5.000000000000e-02,9.426229508197e-01,0.000000000000e+00
+ 465,0.000000000000e+00,9.508196721311e-01,1.000000000000e+00
+ 466,5.000000000000e-02,9.508196721311e-01,1.000000000000e+00
+ 467,0.000000000000e+00,9.508196721311e-01,0.000000000000e+00
+ 468,5.000000000000e-02,9.508196721311e-01,0.000000000000e+00
+ 469,0.000000000000e+00,9.590163934426e-01,1.000000000000e+00
+ 470,5.000000000000e-02,9.590163934426e-01,1.000000000000e+00
+ 471,0.000000000000e+00,9.590163934426e-01,0.000000000000e+00
+ 472,5.000000000000e-02,9.590163934426e-01,0.000000000000e+00
+ 473,0.000000000000e+00,9.672131147541e-01,1.000000000000e+00
+ 474,5.000000000000e-02,9.672131147541e-01,1.000000000000e+00
+ 475,0.000000000000e+00,9.672131147541e-01,0.000000000000e+00
+ 476,5.000000000000e-02,9.672131147541e-01,0.000000000000e+00
+ 477,0.000000000000e+00,9.754098360656e-01,1.000000000000e+00
+ 478,5.000000000000e-02,9.754098360656e-01,1.000000000000e+00
+ 479,0.000000000000e+00,9.754098360656e-01,0.000000000000e+00
+ 480,5.000000000000e-02,9.754098360656e-01,0.000000000000e+00
+ 481,0.000000000000e+00,9.836065573770e-01,1.000000000000e+00
+ 482,5.000000000000e-02,9.836065573770e-01,1.000000000000e+00
+ 483,0.000000000000e+00,9.836065573770e-01,0.000000000000e+00
+ 484,5.000000000000e-02,9.836065573770e-01,0.000000000000e+00
+ 485,0.000000000000e+00,9.918032786885e-01,1.000000000000e+00
+ 486,5.000000000000e-02,9.918032786885e-01,1.000000000000e+00
+ 487,0.000000000000e+00,9.918032786885e-01,0.000000000000e+00
+ 488,5.000000000000e-02,9.918032786885e-01,0.000000000000e+00
+ 489,0.000000000000e+00,1.000000000000e+00,1.000000000000e+00
+ 490,5.000000000000e-02,1.000000000000e+00,1.000000000000e+00
+ 491,0.000000000000e+00,1.000000000000e+00,0.000000000000e+00
+ 492,5.000000000000e-02,1.000000000000e+00,0.000000000000e+00
+ 493,-5.000000000000e-02,0.000000000000e+00,1.000000000000e+00
+ 494,-5.000000000000e-02,8.196721311475e-03,1.000000000000e+00
+ 495,-5.000000000000e-02,0.000000000000e+00,0.000000000000e+00
+ 496,-5.000000000000e-02,8.196721311475e-03,0.000000000000e+00
+ 497,-5.000000000000e-02,1.639344262295e-02,1.000000000000e+00
+ 498,-5.000000000000e-02,1.639344262295e-02,0.000000000000e+00
+ 499,-5.000000000000e-02,2.459016393443e-02,1.000000000000e+00
+ 500,-5.000000000000e-02,2.459016393443e-02,0.000000000000e+00
+ 501,-5.000000000000e-02,3.278688524590e-02,1.000000000000e+00
+ 502,-5.000000000000e-02,3.278688524590e-02,0.000000000000e+00
+ 503,-5.000000000000e-02,4.098360655738e-02,1.000000000000e+00
+ 504,-5.000000000000e-02,4.098360655738e-02,0.000000000000e+00
+ 505,-5.000000000000e-02,4.918032786885e-02,1.000000000000e+00
+ 506,-5.000000000000e-02,4.918032786885e-02,0.000000000000e+00
+ 507,-5.000000000000e-02,5.737704918033e-02,1.000000000000e+00
+ 508,-5.000000000000e-02,5.737704918033e-02,0.000000000000e+00
+ 509,-5.000000000000e-02,6.557377049180e-02,1.000000000000e+00
+ 510,-5.000000000000e-02,6.557377049180e-02,0.000000000000e+00
+ 511,-5.000000000000e-02,7.377049180328e-02,1.000000000000e+00
+ 512,-5.000000000000e-02,7.377049180328e-02,0.000000000000e+00
+ 513,-5.000000000000e-02,8.196721311475e-02,1.000000000000e+00
+ 514,-5.000000000000e-02,8.196721311475e-02,0.000000000000e+00
+ 515,-5.000000000000e-02,9.016393442623e-02,1.000000000000e+00
+ 516,-5.000000000000e-02,9.016393442623e-02,0.000000000000e+00
+ 517,-5.000000000000e-02,9.836065573770e-02,1.000000000000e+00
+ 518,-5.000000000000e-02,9.836065573770e-02,0.000000000000e+00
+ 519,-5.000000000000e-02,1.065573770492e-01,1.000000000000e+00
+ 520,-5.000000000000e-02,1.065573770492e-01,0.000000000000e+00
+ 521,-5.000000000000e-02,1.147540983607e-01,1.000000000000e+00
+ 522,-5.000000000000e-02,1.147540983607e-01,0.000000000000e+00
+ 523,-5.000000000000e-02,1.229508196721e-01,1.000000000000e+00
+ 524,-5.000000000000e-02,1.229508196721e-01,0.000000000000e+00
+ 525,-5.000000000000e-02,1.311475409836e-01,1.000000000000e+00
+ 526,-5.000000000000e-02,1.311475409836e-01,0.000000000000e+00
+ 527,-5.000000000000e-02,1.393442622951e-01,1.000000000000e+00
+ 528,-5.000000000000e-02,1.393442622951e-01,0.000000000000e+00
+ 529,-5.000000000000e-02,1.475409836066e-01,1.000000000000e+00
+ 530,-5.000000000000e-02,1.475409836066e-01,0.000000000000e+00
+ 531,-5.000000000000e-02,1.557377049180e-01,1.000000000000e+00
+ 532,-5.000000000000e-02,1.557377049180e-01,0.000000000000e+00
+ 533,-5.000000000000e-02,1.639344262295e-01,1.000000000000e+00
+ 534,-5.000000000000e-02,1.639344262295e-01,0.000000000000e+00
+ 535,-5.000000000000e-02,1.721311475410e-01,1.000000000000e+00
+ 536,-5.000000000000e-02,1.721311475410e-01,0.000000000000e+00
+ 537,-5.000000000000e-02,1.803278688525e-01,1.000000000000e+00
+ 538,-5.000000000000e-02,1.803278688525e-01,0.000000000000e+00
+ 539,-5.000000000000e-02,1.885245901639e-01,1.000000000000e+00
+ 540,-5.000000000000e-02,1.885245901639e-01,0.000000000000e+00
+ 541,-5.000000000000e-02,1.967213114754e-01,1.000000000000e+00
+ 542,-5.000000000000e-02,1.967213114754e-01,0.000000000000e+00
+ 543,-5.000000000000e-02,2.049180327869e-01,1.000000000000e+00
+ 544,-5.000000000000e-02,2.049180327869e-01,0.000000000000e+00
+ 545,-5.000000000000e-02,2.131147540984e-01,1.000000000000e+00
+ 546,-5.000000000000e-02,2.131147540984e-01,0.000000000000e+00
+ 547,-5.000000000000e-02,2.213114754098e-01,1.000000000000e+00
+ 548,-5.000000000000e-02,2.213114754098e-01,0.000000000000e+00
+ 549,-5.000000000000e-02,2.295081967213e-01,1.000000000000e+00
+ 550,-5.000000000000e-02,2.295081967213e-01,0.000000000000e+00
+ 551,-5.000000000000e-02,2.377049180328e-01,1.000000000000e+00
+ 552,-5.000000000000e-02,2.377049180328e-01,0.000000000000e+00
+ 553,-5.000000000000e-02,2.459016393443e-01,1.000000000000e+00
+ 554,-5.000000000000e-02,2.459016393443e-01,0.000000000000e+00
+ 555,-5.000000000000e-02,2.540983606557e-01,1.000000000000e+00
+ 556,-5.000000000000e-02,2.540983606557e-01,0.000000000000e+00
+ 557,-5.000000000000e-02,2.622950819672e-01,1.000000000000e+00
+ 558,-5.000000000000e-02,2.622950819672e-01,0.000000000000e+00
+ 559,-5.000000000000e-02,2.704918032787e-01,1.000000000000e+00
+ 560,-5.000000000000e-02,2.704918032787e-01,0.000000000000e+00
+ 561,-5.000000000000e-02,2.786885245902e-01,1.000000000000e+00
+ 562,-5.000000000000e-02,2.786885245902e-01,0.000000000000e+00
+ 563,-5.000000000000e-02,2.868852459016e-01,1.000000000000e+00
+ 564,-5.000000000000e-02,2.868852459016e-01,0.000000000000e+00
+ 565,-5.000000000000e-02,2.950819672131e-01,1.000000000000e+00
+ 566,-5.000000000000e-02,2.950819672131e-01,0.000000000000e+00
+ 567,-5.000000000000e-02,3.032786885246e-01,1.000000000000e+00
+ 568,-5.000000000000e-02,3.032786885246e-01,0.000000000000e+00
+ 569,-5.000000000000e-02,3.114754098361e-01,1.000000000000e+00
+ 570,-5.000000000000e-02,3.114754098361e-01,0.000000000000e+00
+ 571,-5.000000000000e-02,3.196721311475e-01,1.000000000000e+00
+ 572,-5.000000000000e-02,3.196721311475e-01,0.000000000000e+00
+ 573,-5.000000000000e-02,3.278688524590e-01,1.000000000000e+00
+ 574,-5.000000000000e-02,3.278688524590e-01,0.000000000000e+00
+ 575,-5.000000000000e-02,3.360655737705e-01,1.000000000000e+00
+ 576,-5.000000000000e-02,3.360655737705e-01,0.000000000000e+00
+ 577,-5.000000000000e-02,3.442622950820e-01,1.000000000000e+00
+ 578,-5.000000000000e-02,3.442622950820e-01,0.000000000000e+00
+ 579,-5.000000000000e-02,3.524590163934e-01,1.000000000000e+00
+ 580,-5.000000000000e-02,3.524590163934e-01,0.000000000000e+00
+ 581,-5.000000000000e-02,3.606557377049e-01,1.000000000000e+00
+ 582,-5.000000000000e-02,3.606557377049e-01,0.000000000000e+00
+ 583,-5.000000000000e-02,3.688524590164e-01,1.000000000000e+00
+ 584,-5.000000000000e-02,3.688524590164e-01,0.000000000000e+00
+ 585,-5.000000000000e-02,3.770491803279e-01,1.000000000000e+00
+ 586,-5.000000000000e-02,3.770491803279e-01,0.000000000000e+00
+ 587,-5.000000000000e-02,3.852459016393e-01,1.000000000000e+00
+ 588,-5.000000000000e-02,3.852459016393e-01,0.000000000000e+00
+ 589,-5.000000000000e-02,3.934426229508e-01,1.000000000000e+00
+ 590,-5.000000000000e-02,3.934426229508e-01,0.000000000000e+00
+ 591,-5.000000000000e-02,4.016393442623e-01,1.000000000000e+00
+ 592,-5.000000000000e-02,4.016393442623e-01,0.000000000000e+00
+ 593,-5.000000000000e-02,4.098360655738e-01,1.000000000000e+00
+ 594,-5.000000000000e-02,4.098360655738e-01,0.000000000000e+00
+ 595,-5.000000000000e-02,4.180327868852e-01,1.000000000000e+00
+ 596,-5.000000000000e-02,4.180327868852e-01,0.000000000000e+00
+ 597,-5.000000000000e-02,4.262295081967e-01,1.000000000000e+00
+ 598,-5.000000000000e-02,4.262295081967e-01,0.000000000000e+00
+ 599,-5.000000000000e-02,4.344262295082e-01,1.000000000000e+00
+ 600,-5.000000000000e-02,4.344262295082e-01,0.000000000000e+00
+ 601,-5.000000000000e-02,4.426229508197e-01,1.000000000000e+00
+ 602,-5.000000000000e-02,4.426229508197e-01,0.000000000000e+00
+ 603,-5.000000000000e-02,4.508196721311e-01,1.000000000000e+00
+ 604,-5.000000000000e-02,4.508196721311e-01,0.000000000000e+00
+ 605,-5.000000000000e-02,4.590163934426e-01,1.000000000000e+00
+ 606,-5.000000000000e-02,4.590163934426e-01,0.000000000000e+00
+ 607,-5.000000000000e-02,4.672131147541e-01,1.000000000000e+00
+ 608,-5.000000000000e-02,4.672131147541e-01,0.000000000000e+00
+ 609,-5.000000000000e-02,4.754098360656e-01,1.000000000000e+00
+ 610,-5.000000000000e-02,4.754098360656e-01,0.000000000000e+00
+ 611,-5.000000000000e-02,4.836065573770e-01,1.000000000000e+00
+ 612,-5.000000000000e-02,4.836065573770e-01,0.000000000000e+00
+ 613,-5.000000000000e-02,4.918032786885e-01,1.000000000000e+00
+ 614,-5.000000000000e-02,4.918032786885e-01,0.000000000000e+00
+ 615,-5.000000000000e-02,5.000000000000e-01,1.000000000000e+00
+ 616,-5.000000000000e-02,5.000000000000e-01,0.000000000000e+00
+ 617,-5.000000000000e-02,5.081967213115e-01,1.000000000000e+00
+ 618,-5.000000000000e-02,5.081967213115e-01,0.000000000000e+00
+ 619,-5.000000000000e-02,5.163934426230e-01,1.000000000000e+00
+ 620,-5.000000000000e-02,5.163934426230e-01,0.000000000000e+00
+ 621,-5.000000000000e-02,5.245901639344e-01,1.000000000000e+00
+ 622,-5.000000000000e-02,5.245901639344e-01,0.000000000000e+00
+ 623,-5.000000000000e-02,5.327868852459e-01,1.000000000000e+00
+ 624,-5.000000000000e-02,5.327868852459e-01,0.000000000000e+00
+ 625,-5.000000000000e-02,5.409836065574e-01,1.000000000000e+00
+ 626,-5.000000000000e-02,5.409836065574e-01,0.000000000000e+00
+ 627,-5.000000000000e-02,5.491803278689e-01,1.000000000000e+00
+ 628,-5.000000000000e-02,5.491803278689e-01,0.000000000000e+00
+ 629,-5.000000000000e-02,5.573770491803e-01,1.000000000000e+00
+ 630,-5.000000000000e-02,5.573770491803e-01,0.000000000000e+00
+ 631,-5.000000000000e-02,5.655737704918e-01,1.000000000000e+00
+ 632,-5.000000000000e-02,5.655737704918e-01,0.000000000000e+00
+ 633,-5.000000000000e-02,5.737704918033e-01,1.000000000000e+00
+ 634,-5.000000000000e-02,5.737704918033e-01,0.000000000000e+00
+ 635,-5.000000000000e-02,5.819672131148e-01,1.000000000000e+00
+ 636,-5.000000000000e-02,5.819672131148e-01,0.000000000000e+00
+ 637,-5.000000000000e-02,5.901639344262e-01,1.000000000000e+00
+ 638,-5.000000000000e-02,5.901639344262e-01,0.000000000000e+00
+ 639,-5.000000000000e-02,5.983606557377e-01,1.000000000000e+00
+ 640,-5.000000000000e-02,5.983606557377e-01,0.000000000000e+00
+ 641,-5.000000000000e-02,6.065573770492e-01,1.000000000000e+00
+ 642,-5.000000000000e-02,6.065573770492e-01,0.000000000000e+00
+ 643,-5.000000000000e-02,6.147540983607e-01,1.000000000000e+00
+ 644,-5.000000000000e-02,6.147540983607e-01,0.000000000000e+00
+ 645,-5.000000000000e-02,6.229508196721e-01,1.000000000000e+00
+ 646,-5.000000000000e-02,6.229508196721e-01,0.000000000000e+00
+ 647,-5.000000000000e-02,6.311475409836e-01,1.000000000000e+00
+ 648,-5.000000000000e-02,6.311475409836e-01,0.000000000000e+00
+ 649,-5.000000000000e-02,6.393442622951e-01,1.000000000000e+00
+ 650,-5.000000000000e-02,6.393442622951e-01,0.000000000000e+00
+ 651,-5.000000000000e-02,6.475409836066e-01,1.000000000000e+00
+ 652,-5.000000000000e-02,6.475409836066e-01,0.000000000000e+00
+ 653,-5.000000000000e-02,6.557377049180e-01,1.000000000000e+00
+ 654,-5.000000000000e-02,6.557377049180e-01,0.000000000000e+00
+ 655,-5.000000000000e-02,6.639344262295e-01,1.000000000000e+00
+ 656,-5.000000000000e-02,6.639344262295e-01,0.000000000000e+00
+ 657,-5.000000000000e-02,6.721311475410e-01,1.000000000000e+00
+ 658,-5.000000000000e-02,6.721311475410e-01,0.000000000000e+00
+ 659,-5.000000000000e-02,6.803278688525e-01,1.000000000000e+00
+ 660,-5.000000000000e-02,6.803278688525e-01,0.000000000000e+00
+ 661,-5.000000000000e-02,6.885245901639e-01,1.000000000000e+00
+ 662,-5.000000000000e-02,6.885245901639e-01,0.000000000000e+00
+ 663,-5.000000000000e-02,6.967213114754e-01,1.000000000000e+00
+ 664,-5.000000000000e-02,6.967213114754e-01,0.000000000000e+00
+ 665,-5.000000000000e-02,7.049180327869e-01,1.000000000000e+00
+ 666,-5.000000000000e-02,7.049180327869e-01,0.000000000000e+00
+ 667,-5.000000000000e-02,7.131147540984e-01,1.000000000000e+00
+ 668,-5.000000000000e-02,7.131147540984e-01,0.000000000000e+00
+ 669,-5.000000000000e-02,7.213114754098e-01,1.000000000000e+00
+ 670,-5.000000000000e-02,7.213114754098e-01,0.000000000000e+00
+ 671,-5.000000000000e-02,7.295081967213e-01,1.000000000000e+00
+ 672,-5.000000000000e-02,7.295081967213e-01,0.000000000000e+00
+ 673,-5.000000000000e-02,7.377049180328e-01,1.000000000000e+00
+ 674,-5.000000000000e-02,7.377049180328e-01,0.000000000000e+00
+ 675,-5.000000000000e-02,7.459016393443e-01,1.000000000000e+00
+ 676,-5.000000000000e-02,7.459016393443e-01,0.000000000000e+00
+ 677,-5.000000000000e-02,7.540983606557e-01,1.000000000000e+00
+ 678,-5.000000000000e-02,7.540983606557e-01,0.000000000000e+00
+ 679,-5.000000000000e-02,7.622950819672e-01,1.000000000000e+00
+ 680,-5.000000000000e-02,7.622950819672e-01,0.000000000000e+00
+ 681,-5.000000000000e-02,7.704918032787e-01,1.000000000000e+00
+ 682,-5.000000000000e-02,7.704918032787e-01,0.000000000000e+00
+ 683,-5.000000000000e-02,7.786885245902e-01,1.000000000000e+00
+ 684,-5.000000000000e-02,7.786885245902e-01,0.000000000000e+00
+ 685,-5.000000000000e-02,7.868852459016e-01,1.000000000000e+00
+ 686,-5.000000000000e-02,7.868852459016e-01,0.000000000000e+00
+ 687,-5.000000000000e-02,7.950819672131e-01,1.000000000000e+00
+ 688,-5.000000000000e-02,7.950819672131e-01,0.000000000000e+00
+ 689,-5.000000000000e-02,8.032786885246e-01,1.000000000000e+00
+ 690,-5.000000000000e-02,8.032786885246e-01,0.000000000000e+00
+ 691,-5.000000000000e-02,8.114754098361e-01,1.000000000000e+00
+ 692,-5.000000000000e-02,8.114754098361e-01,0.000000000000e+00
+ 693,-5.000000000000e-02,8.196721311475e-01,1.000000000000e+00
+ 694,-5.000000000000e-02,8.196721311475e-01,0.000000000000e+00
+ 695,-5.000000000000e-02,8.278688524590e-01,1.000000000000e+00
+ 696,-5.000000000000e-02,8.278688524590e-01,0.000000000000e+00
+ 697,-5.000000000000e-02,8.360655737705e-01,1.000000000000e+00
+ 698,-5.000000000000e-02,8.360655737705e-01,0.000000000000e+00
+ 699,-5.000000000000e-02,8.442622950820e-01,1.000000000000e+00
+ 700,-5.000000000000e-02,8.442622950820e-01,0.000000000000e+00
+ 701,-5.000000000000e-02,8.524590163934e-01,1.000000000000e+00
+ 702,-5.000000000000e-02,8.524590163934e-01,0.000000000000e+00
+ 703,-5.000000000000e-02,8.606557377049e-01,1.000000000000e+00
+ 704,-5.000000000000e-02,8.606557377049e-01,0.000000000000e+00
+ 705,-5.000000000000e-02,8.688524590164e-01,1.000000000000e+00
+ 706,-5.000000000000e-02,8.688524590164e-01,0.000000000000e+00
+ 707,-5.000000000000e-02,8.770491803279e-01,1.000000000000e+00
+ 708,-5.000000000000e-02,8.770491803279e-01,0.000000000000e+00
+ 709,-5.000000000000e-02,8.852459016393e-01,1.000000000000e+00
+ 710,-5.000000000000e-02,8.852459016393e-01,0.000000000000e+00
+ 711,-5.000000000000e-02,8.934426229508e-01,1.000000000000e+00
+ 712,-5.000000000000e-02,8.934426229508e-01,0.000000000000e+00
+ 713,-5.000000000000e-02,9.016393442623e-01,1.000000000000e+00
+ 714,-5.000000000000e-02,9.016393442623e-01,0.000000000000e+00
+ 715,-5.000000000000e-02,9.098360655738e-01,1.000000000000e+00
+ 716,-5.000000000000e-02,9.098360655738e-01,0.000000000000e+00
+ 717,-5.000000000000e-02,9.180327868852e-01,1.000000000000e+00
+ 718,-5.000000000000e-02,9.180327868852e-01,0.000000000000e+00
+ 719,-5.000000000000e-02,9.262295081967e-01,1.000000000000e+00
+ 720,-5.000000000000e-02,9.262295081967e-01,0.000000000000e+00
+ 721,-5.000000000000e-02,9.344262295082e-01,1.000000000000e+00
+ 722,-5.000000000000e-02,9.344262295082e-01,0.000000000000e+00
+ 723,-5.000000000000e-02,9.426229508197e-01,1.000000000000e+00
+ 724,-5.000000000000e-02,9.426229508197e-01,0.000000000000e+00
+ 725,-5.000000000000e-02,9.508196721311e-01,1.000000000000e+00
+ 726,-5.000000000000e-02,9.508196721311e-01,0.000000000000e+00
+ 727,-5.000000000000e-02,9.590163934426e-01,1.000000000000e+00
+ 728,-5.000000000000e-02,9.590163934426e-01,0.000000000000e+00
+ 729,-5.000000000000e-02,9.672131147541e-01,1.000000000000e+00
+ 730,-5.000000000000e-02,9.672131147541e-01,0.000000000000e+00
+ 731,-5.000000000000e-02,9.754098360656e-01,1.000000000000e+00
+ 732,-5.000000000000e-02,9.754098360656e-01,0.000000000000e+00
+ 733,-5.000000000000e-02,9.836065573770e-01,1.000000000000e+00
+ 734,-5.000000000000e-02,9.836065573770e-01,0.000000000000e+00
+ 735,-5.000000000000e-02,9.918032786885e-01,1.000000000000e+00
+ 736,-5.000000000000e-02,9.918032786885e-01,0.000000000000e+00
+ 737,-5.000000000000e-02,1.000000000000e+00,1.000000000000e+00
+ 738,-5.000000000000e-02,1.000000000000e+00,0.000000000000e+00
+*ELEMENT, TYPE=C3D8, ELSET=Eall
+ 1, 1, 2, 3, 4, 5, 6, 7, 8
+ 2, 4, 3, 9, 10, 8, 7, 11, 12
+ 3, 10, 9, 13, 14, 12, 11, 15, 16
+ 4, 14, 13, 17, 18, 16, 15, 19, 20
+ 5, 18, 17, 21, 22, 20, 19, 23, 24
+ 6, 22, 21, 25, 26, 24, 23, 27, 28
+ 7, 26, 25, 29, 30, 28, 27, 31, 32
+ 8, 30, 29, 33, 34, 32, 31, 35, 36
+ 9, 34, 33, 37, 38, 36, 35, 39, 40
+ 10, 38, 37, 41, 42, 40, 39, 43, 44
+ 11, 42, 41, 45, 46, 44, 43, 47, 48
+ 12, 46, 45, 49, 50, 48, 47, 51, 52
+ 13, 50, 49, 53, 54, 52, 51, 55, 56
+ 14, 54, 53, 57, 58, 56, 55, 59, 60
+ 15, 58, 57, 61, 62, 60, 59, 63, 64
+ 16, 62, 61, 65, 66, 64, 63, 67, 68
+ 17, 66, 65, 69, 70, 68, 67, 71, 72
+ 18, 70, 69, 73, 74, 72, 71, 75, 76
+ 19, 74, 73, 77, 78, 76, 75, 79, 80
+ 20, 78, 77, 81, 82, 80, 79, 83, 84
+ 21, 82, 81, 85, 86, 84, 83, 87, 88
+ 22, 86, 85, 89, 90, 88, 87, 91, 92
+ 23, 90, 89, 93, 94, 92, 91, 95, 96
+ 24, 94, 93, 97, 98, 96, 95, 99, 100
+ 25, 98, 97, 101, 102, 100, 99, 103, 104
+ 26, 102, 101, 105, 106, 104, 103, 107, 108
+ 27, 106, 105, 109, 110, 108, 107, 111, 112
+ 28, 110, 109, 113, 114, 112, 111, 115, 116
+ 29, 114, 113, 117, 118, 116, 115, 119, 120
+ 30, 118, 117, 121, 122, 120, 119, 123, 124
+ 31, 122, 121, 125, 126, 124, 123, 127, 128
+ 32, 126, 125, 129, 130, 128, 127, 131, 132
+ 33, 130, 129, 133, 134, 132, 131, 135, 136
+ 34, 134, 133, 137, 138, 136, 135, 139, 140
+ 35, 138, 137, 141, 142, 140, 139, 143, 144
+ 36, 142, 141, 145, 146, 144, 143, 147, 148
+ 37, 146, 145, 149, 150, 148, 147, 151, 152
+ 38, 150, 149, 153, 154, 152, 151, 155, 156
+ 39, 154, 153, 157, 158, 156, 155, 159, 160
+ 40, 158, 157, 161, 162, 160, 159, 163, 164
+ 41, 162, 161, 165, 166, 164, 163, 167, 168
+ 42, 166, 165, 169, 170, 168, 167, 171, 172
+ 43, 170, 169, 173, 174, 172, 171, 175, 176
+ 44, 174, 173, 177, 178, 176, 175, 179, 180
+ 45, 178, 177, 181, 182, 180, 179, 183, 184
+ 46, 182, 181, 185, 186, 184, 183, 187, 188
+ 47, 186, 185, 189, 190, 188, 187, 191, 192
+ 48, 190, 189, 193, 194, 192, 191, 195, 196
+ 49, 194, 193, 197, 198, 196, 195, 199, 200
+ 50, 198, 197, 201, 202, 200, 199, 203, 204
+ 51, 202, 201, 205, 206, 204, 203, 207, 208
+ 52, 206, 205, 209, 210, 208, 207, 211, 212
+ 53, 210, 209, 213, 214, 212, 211, 215, 216
+ 54, 214, 213, 217, 218, 216, 215, 219, 220
+ 55, 218, 217, 221, 222, 220, 219, 223, 224
+ 56, 222, 221, 225, 226, 224, 223, 227, 228
+ 57, 226, 225, 229, 230, 228, 227, 231, 232
+ 58, 230, 229, 233, 234, 232, 231, 235, 236
+ 59, 234, 233, 237, 238, 236, 235, 239, 240
+ 60, 238, 237, 241, 242, 240, 239, 243, 244
+ 61, 242, 241, 245, 246, 244, 243, 247, 248
+ 62, 246, 245, 249, 250, 248, 247, 251, 252
+ 63, 250, 249, 253, 254, 252, 251, 255, 256
+ 64, 254, 253, 257, 258, 256, 255, 259, 260
+ 65, 258, 257, 261, 262, 260, 259, 263, 264
+ 66, 262, 261, 265, 266, 264, 263, 267, 268
+ 67, 266, 265, 269, 270, 268, 267, 271, 272
+ 68, 270, 269, 273, 274, 272, 271, 275, 276
+ 69, 274, 273, 277, 278, 276, 275, 279, 280
+ 70, 278, 277, 281, 282, 280, 279, 283, 284
+ 71, 282, 281, 285, 286, 284, 283, 287, 288
+ 72, 286, 285, 289, 290, 288, 287, 291, 292
+ 73, 290, 289, 293, 294, 292, 291, 295, 296
+ 74, 294, 293, 297, 298, 296, 295, 299, 300
+ 75, 298, 297, 301, 302, 300, 299, 303, 304
+ 76, 302, 301, 305, 306, 304, 303, 307, 308
+ 77, 306, 305, 309, 310, 308, 307, 311, 312
+ 78, 310, 309, 313, 314, 312, 311, 315, 316
+ 79, 314, 313, 317, 318, 316, 315, 319, 320
+ 80, 318, 317, 321, 322, 320, 319, 323, 324
+ 81, 322, 321, 325, 326, 324, 323, 327, 328
+ 82, 326, 325, 329, 330, 328, 327, 331, 332
+ 83, 330, 329, 333, 334, 332, 331, 335, 336
+ 84, 334, 333, 337, 338, 336, 335, 339, 340
+ 85, 338, 337, 341, 342, 340, 339, 343, 344
+ 86, 342, 341, 345, 346, 344, 343, 347, 348
+ 87, 346, 345, 349, 350, 348, 347, 351, 352
+ 88, 350, 349, 353, 354, 352, 351, 355, 356
+ 89, 354, 353, 357, 358, 356, 355, 359, 360
+ 90, 358, 357, 361, 362, 360, 359, 363, 364
+ 91, 362, 361, 365, 366, 364, 363, 367, 368
+ 92, 366, 365, 369, 370, 368, 367, 371, 372
+ 93, 370, 369, 373, 374, 372, 371, 375, 376
+ 94, 374, 373, 377, 378, 376, 375, 379, 380
+ 95, 378, 377, 381, 382, 380, 379, 383, 384
+ 96, 382, 381, 385, 386, 384, 383, 387, 388
+ 97, 386, 385, 389, 390, 388, 387, 391, 392
+ 98, 390, 389, 393, 394, 392, 391, 395, 396
+ 99, 394, 393, 397, 398, 396, 395, 399, 400
+ 100, 398, 397, 401, 402, 400, 399, 403, 404
+ 101, 402, 401, 405, 406, 404, 403, 407, 408
+ 102, 406, 405, 409, 410, 408, 407, 411, 412
+ 103, 410, 409, 413, 414, 412, 411, 415, 416
+ 104, 414, 413, 417, 418, 416, 415, 419, 420
+ 105, 418, 417, 421, 422, 420, 419, 423, 424
+ 106, 422, 421, 425, 426, 424, 423, 427, 428
+ 107, 426, 425, 429, 430, 428, 427, 431, 432
+ 108, 430, 429, 433, 434, 432, 431, 435, 436
+ 109, 434, 433, 437, 438, 436, 435, 439, 440
+ 110, 438, 437, 441, 442, 440, 439, 443, 444
+ 111, 442, 441, 445, 446, 444, 443, 447, 448
+ 112, 446, 445, 449, 450, 448, 447, 451, 452
+ 113, 450, 449, 453, 454, 452, 451, 455, 456
+ 114, 454, 453, 457, 458, 456, 455, 459, 460
+ 115, 458, 457, 461, 462, 460, 459, 463, 464
+ 116, 462, 461, 465, 466, 464, 463, 467, 468
+ 117, 466, 465, 469, 470, 468, 467, 471, 472
+ 118, 470, 469, 473, 474, 472, 471, 475, 476
+ 119, 474, 473, 477, 478, 476, 475, 479, 480
+ 120, 478, 477, 481, 482, 480, 479, 483, 484
+ 121, 482, 481, 485, 486, 484, 483, 487, 488
+ 122, 486, 485, 489, 490, 488, 487, 491, 492
+ 123, 2, 493, 494, 3, 6, 495, 496, 7
+ 124, 3, 494, 497, 9, 7, 496, 498, 11
+ 125, 9, 497, 499, 13, 11, 498, 500, 15
+ 126, 13, 499, 501, 17, 15, 500, 502, 19
+ 127, 17, 501, 503, 21, 19, 502, 504, 23
+ 128, 21, 503, 505, 25, 23, 504, 506, 27
+ 129, 25, 505, 507, 29, 27, 506, 508, 31
+ 130, 29, 507, 509, 33, 31, 508, 510, 35
+ 131, 33, 509, 511, 37, 35, 510, 512, 39
+ 132, 37, 511, 513, 41, 39, 512, 514, 43
+ 133, 41, 513, 515, 45, 43, 514, 516, 47
+ 134, 45, 515, 517, 49, 47, 516, 518, 51
+ 135, 49, 517, 519, 53, 51, 518, 520, 55
+ 136, 53, 519, 521, 57, 55, 520, 522, 59
+ 137, 57, 521, 523, 61, 59, 522, 524, 63
+ 138, 61, 523, 525, 65, 63, 524, 526, 67
+ 139, 65, 525, 527, 69, 67, 526, 528, 71
+ 140, 69, 527, 529, 73, 71, 528, 530, 75
+ 141, 73, 529, 531, 77, 75, 530, 532, 79
+ 142, 77, 531, 533, 81, 79, 532, 534, 83
+ 143, 81, 533, 535, 85, 83, 534, 536, 87
+ 144, 85, 535, 537, 89, 87, 536, 538, 91
+ 145, 89, 537, 539, 93, 91, 538, 540, 95
+ 146, 93, 539, 541, 97, 95, 540, 542, 99
+ 147, 97, 541, 543, 101, 99, 542, 544, 103
+ 148, 101, 543, 545, 105, 103, 544, 546, 107
+ 149, 105, 545, 547, 109, 107, 546, 548, 111
+ 150, 109, 547, 549, 113, 111, 548, 550, 115
+ 151, 113, 549, 551, 117, 115, 550, 552, 119
+ 152, 117, 551, 553, 121, 119, 552, 554, 123
+ 153, 121, 553, 555, 125, 123, 554, 556, 127
+ 154, 125, 555, 557, 129, 127, 556, 558, 131
+ 155, 129, 557, 559, 133, 131, 558, 560, 135
+ 156, 133, 559, 561, 137, 135, 560, 562, 139
+ 157, 137, 561, 563, 141, 139, 562, 564, 143
+ 158, 141, 563, 565, 145, 143, 564, 566, 147
+ 159, 145, 565, 567, 149, 147, 566, 568, 151
+ 160, 149, 567, 569, 153, 151, 568, 570, 155
+ 161, 153, 569, 571, 157, 155, 570, 572, 159
+ 162, 157, 571, 573, 161, 159, 572, 574, 163
+ 163, 161, 573, 575, 165, 163, 574, 576, 167
+ 164, 165, 575, 577, 169, 167, 576, 578, 171
+ 165, 169, 577, 579, 173, 171, 578, 580, 175
+ 166, 173, 579, 581, 177, 175, 580, 582, 179
+ 167, 177, 581, 583, 181, 179, 582, 584, 183
+ 168, 181, 583, 585, 185, 183, 584, 586, 187
+ 169, 185, 585, 587, 189, 187, 586, 588, 191
+ 170, 189, 587, 589, 193, 191, 588, 590, 195
+ 171, 193, 589, 591, 197, 195, 590, 592, 199
+ 172, 197, 591, 593, 201, 199, 592, 594, 203
+ 173, 201, 593, 595, 205, 203, 594, 596, 207
+ 174, 205, 595, 597, 209, 207, 596, 598, 211
+ 175, 209, 597, 599, 213, 211, 598, 600, 215
+ 176, 213, 599, 601, 217, 215, 600, 602, 219
+ 177, 217, 601, 603, 221, 219, 602, 604, 223
+ 178, 221, 603, 605, 225, 223, 604, 606, 227
+ 179, 225, 605, 607, 229, 227, 606, 608, 231
+ 180, 229, 607, 609, 233, 231, 608, 610, 235
+ 181, 233, 609, 611, 237, 235, 610, 612, 239
+ 182, 237, 611, 613, 241, 239, 612, 614, 243
+ 183, 241, 613, 615, 245, 243, 614, 616, 247
+ 184, 245, 615, 617, 249, 247, 616, 618, 251
+ 185, 249, 617, 619, 253, 251, 618, 620, 255
+ 186, 253, 619, 621, 257, 255, 620, 622, 259
+ 187, 257, 621, 623, 261, 259, 622, 624, 263
+ 188, 261, 623, 625, 265, 263, 624, 626, 267
+ 189, 265, 625, 627, 269, 267, 626, 628, 271
+ 190, 269, 627, 629, 273, 271, 628, 630, 275
+ 191, 273, 629, 631, 277, 275, 630, 632, 279
+ 192, 277, 631, 633, 281, 279, 632, 634, 283
+ 193, 281, 633, 635, 285, 283, 634, 636, 287
+ 194, 285, 635, 637, 289, 287, 636, 638, 291
+ 195, 289, 637, 639, 293, 291, 638, 640, 295
+ 196, 293, 639, 641, 297, 295, 640, 642, 299
+ 197, 297, 641, 643, 301, 299, 642, 644, 303
+ 198, 301, 643, 645, 305, 303, 644, 646, 307
+ 199, 305, 645, 647, 309, 307, 646, 648, 311
+ 200, 309, 647, 649, 313, 311, 648, 650, 315
+ 201, 313, 649, 651, 317, 315, 650, 652, 319
+ 202, 317, 651, 653, 321, 319, 652, 654, 323
+ 203, 321, 653, 655, 325, 323, 654, 656, 327
+ 204, 325, 655, 657, 329, 327, 656, 658, 331
+ 205, 329, 657, 659, 333, 331, 658, 660, 335
+ 206, 333, 659, 661, 337, 335, 660, 662, 339
+ 207, 337, 661, 663, 341, 339, 662, 664, 343
+ 208, 341, 663, 665, 345, 343, 664, 666, 347
+ 209, 345, 665, 667, 349, 347, 666, 668, 351
+ 210, 349, 667, 669, 353, 351, 668, 670, 355
+ 211, 353, 669, 671, 357, 355, 670, 672, 359
+ 212, 357, 671, 673, 361, 359, 672, 674, 363
+ 213, 361, 673, 675, 365, 363, 674, 676, 367
+ 214, 365, 675, 677, 369, 367, 676, 678, 371
+ 215, 369, 677, 679, 373, 371, 678, 680, 375
+ 216, 373, 679, 681, 377, 375, 680, 682, 379
+ 217, 377, 681, 683, 381, 379, 682, 684, 383
+ 218, 381, 683, 685, 385, 383, 684, 686, 387
+ 219, 385, 685, 687, 389, 387, 686, 688, 391
+ 220, 389, 687, 689, 393, 391, 688, 690, 395
+ 221, 393, 689, 691, 397, 395, 690, 692, 399
+ 222, 397, 691, 693, 401, 399, 692, 694, 403
+ 223, 401, 693, 695, 405, 403, 694, 696, 407
+ 224, 405, 695, 697, 409, 407, 696, 698, 411
+ 225, 409, 697, 699, 413, 411, 698, 700, 415
+ 226, 413, 699, 701, 417, 415, 700, 702, 419
+ 227, 417, 701, 703, 421, 419, 702, 704, 423
+ 228, 421, 703, 705, 425, 423, 704, 706, 427
+ 229, 425, 705, 707, 429, 427, 706, 708, 431
+ 230, 429, 707, 709, 433, 431, 708, 710, 435
+ 231, 433, 709, 711, 437, 435, 710, 712, 439
+ 232, 437, 711, 713, 441, 439, 712, 714, 443
+ 233, 441, 713, 715, 445, 443, 714, 716, 447
+ 234, 445, 715, 717, 449, 447, 716, 718, 451
+ 235, 449, 717, 719, 453, 451, 718, 720, 455
+ 236, 453, 719, 721, 457, 455, 720, 722, 459
+ 237, 457, 721, 723, 461, 459, 722, 724, 463
+ 238, 461, 723, 725, 465, 463, 724, 726, 467
+ 239, 465, 725, 727, 469, 467, 726, 728, 471
+ 240, 469, 727, 729, 473, 471, 728, 730, 475
+ 241, 473, 729, 731, 477, 475, 730, 732, 479
+ 242, 477, 731, 733, 481, 479, 732, 734, 483
+ 243, 481, 733, 735, 485, 483, 734, 736, 487
+ 244, 485, 735, 737, 489, 487, 736, 738, 491
diff --git a/perpendicular-flap/solid-calculix/clean.sh b/perpendicular-flap/solid-calculix/clean.sh
new file mode 100755
index 000000000..e93f04f3c
--- /dev/null
+++ b/perpendicular-flap/solid-calculix/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_calculix .
diff --git a/perpendicular-flap/solid-calculix/config.yml b/perpendicular-flap/solid-calculix/config.yml
new file mode 100644
index 000000000..fde737c49
--- /dev/null
+++ b/perpendicular-flap/solid-calculix/config.yml
@@ -0,0 +1,10 @@
+participants:
+
+ Solid:
+ interfaces:
+ - nodes-mesh: Solid-Mesh
+ patch: surface
+ read-data: [Force]
+ write-data: [Displacement]
+
+precice-config-file: ../precice-config.xml
diff --git a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/fix1_beam.nam b/perpendicular-flap/solid-calculix/fix1_beam.nam
similarity index 82%
rename from FSI/flap_perp/OpenFOAM-CalculiX/Solid/fix1_beam.nam
rename to perpendicular-flap/solid-calculix/fix1_beam.nam
index a6156b9ad..a56356e45 100644
--- a/FSI/flap_perp/OpenFOAM-CalculiX/Solid/fix1_beam.nam
+++ b/perpendicular-flap/solid-calculix/fix1_beam.nam
@@ -4,5 +4,5 @@
2,
5,
6,
-85,
-87,
+493,
+495,
diff --git a/FSI/flap_perp/SU2-CalculiX/Solid/flap.inp b/perpendicular-flap/solid-calculix/flap.inp
similarity index 57%
rename from FSI/flap_perp/SU2-CalculiX/Solid/flap.inp
rename to perpendicular-flap/solid-calculix/flap.inp
index 34da0dafb..44145246c 100644
--- a/FSI/flap_perp/SU2-CalculiX/Solid/flap.inp
+++ b/perpendicular-flap/solid-calculix/flap.inp
@@ -1,19 +1,19 @@
-*INCLUDE, INPUT=Solid/all.msh
-*INCLUDE, INPUT=Solid/fix1_beam.nam
-*INCLUDE, INPUT=Solid/interface_beam.nam
+*INCLUDE, INPUT=all.msh
+*INCLUDE, INPUT=fix1_beam.nam
+*INCLUDE, INPUT=interface_beam.nam
*MATERIAL, Name=EL
*ELASTIC
- 200000, 0.3
+ 4000000, 0.3
*DENSITY
3000
*SOLID SECTION, Elset=Eall, Material=EL
-*STEP, NLGEOM, INC=1000000
-*DYNAMIC
+*STEP, INC=1000000
+*DYNAMIC, ALPHA=0.0
1.E-2, 5.0
*BOUNDARY
Nfix1, 1, 3
*BOUNDARY
-Nall, 2, 2
+Nall, 3
*CLOAD
Nsurface, 1, 0.0
Nsurface, 2, 0.0
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/surface.nam b/perpendicular-flap/solid-calculix/interface_beam.nam
similarity index 58%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/surface.nam
rename to perpendicular-flap/solid-calculix/interface_beam.nam
index 1eb1949f5..dee1553bb 100644
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Solid/surface.nam
+++ b/perpendicular-flap/solid-calculix/interface_beam.nam
@@ -140,12 +140,188 @@
276,
278,
280,
-281,
282,
-283,
284,
-425,
+286,
+288,
+290,
+292,
+294,
+296,
+298,
+300,
+302,
+304,
+306,
+308,
+310,
+312,
+314,
+316,
+318,
+320,
+322,
+324,
+326,
+328,
+330,
+332,
+334,
+336,
+338,
+340,
+342,
+344,
+346,
+348,
+350,
+352,
+354,
+356,
+358,
+360,
+362,
+364,
+366,
+368,
+370,
+372,
+374,
+376,
+378,
+380,
+382,
+384,
+386,
+388,
+390,
+392,
+394,
+396,
+398,
+400,
+402,
+404,
+406,
+408,
+410,
+412,
+414,
+416,
+418,
+420,
+422,
+424,
426,
+428,
+430,
+432,
+434,
+436,
+438,
+440,
+442,
+444,
+446,
+448,
+450,
+452,
+454,
+456,
+458,
+460,
+462,
+464,
+466,
+468,
+470,
+472,
+474,
+476,
+478,
+480,
+482,
+484,
+486,
+488,
+489,
+490,
+491,
+492,
+493,
+494,
+495,
+496,
+497,
+498,
+499,
+500,
+501,
+502,
+503,
+504,
+505,
+506,
+507,
+508,
+509,
+510,
+511,
+512,
+513,
+514,
+515,
+516,
+517,
+518,
+519,
+520,
+521,
+522,
+523,
+524,
+525,
+526,
+527,
+528,
+529,
+530,
+531,
+532,
+533,
+534,
+535,
+536,
+537,
+538,
+539,
+540,
+541,
+542,
+543,
+544,
+545,
+546,
+547,
+548,
+549,
+550,
+551,
+552,
+553,
+554,
+555,
+556,
+557,
+558,
+559,
+560,
+561,
+562,
+563,
+564,
+565,
+566,
567,
568,
569,
@@ -290,3 +466,31 @@
708,
709,
710,
+711,
+712,
+713,
+714,
+715,
+716,
+717,
+718,
+719,
+720,
+721,
+722,
+723,
+724,
+725,
+726,
+727,
+728,
+729,
+730,
+731,
+732,
+733,
+734,
+735,
+736,
+737,
+738,
diff --git a/perpendicular-flap/solid-calculix/run.sh b/perpendicular-flap/solid-calculix/run.sh
new file mode 100755
index 000000000..0cc701cc5
--- /dev/null
+++ b/perpendicular-flap/solid-calculix/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+ccx_preCICE -i flap -precice-participant Solid
diff --git a/perpendicular-flap/solid-dealii/clean.sh b/perpendicular-flap/solid-dealii/clean.sh
new file mode 100755
index 000000000..9ad81b8fb
--- /dev/null
+++ b/perpendicular-flap/solid-dealii/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_dealii .
diff --git a/perpendicular-flap/solid-dealii/parameters.prm b/perpendicular-flap/solid-dealii/parameters.prm
new file mode 100644
index 000000000..7147cad5e
--- /dev/null
+++ b/perpendicular-flap/solid-dealii/parameters.prm
@@ -0,0 +1,81 @@
+# Listing of Parameters
+# Dimensional quantities are in SI units
+# --------------------------------------
+
+subsection Time
+ # End time
+ set End time = 5
+
+ # Time step size
+ set Time step size = 0.01
+
+ # Write results every x timesteps
+ set Output interval = 10
+
+ # Output folder
+ set Output folder = dealii-output
+end
+
+subsection Discretization
+ # Polynomial degree of the FE system
+ set Polynomial degree = 4
+end
+
+subsection System properties
+ # Poisson's ratio
+ set Poisson's ratio = 0.3
+
+ # Shear modulus
+ set Shear modulus = 1538462
+
+ # Density
+ set rho = 3000
+
+ # Body forces x,y,z
+ set body forces = 0.0,0.0,0.0
+end
+
+subsection Solver
+ # Structural model to be used: linear or neo-Hookean
+ set Model = linear
+
+ # Linear solver: CG or Direct
+ set Solver type = Direct
+
+ # Max CG solver iterations (multiples of the system matrix size)
+ # In 2D, this value is best set at 2. In 3D, a value of 1 works fine.
+ set Max iteration multiplier = 1
+
+ # Relative drop criterion for CG solver residual (multiplied by residual norm, ignored if Model == linear or solver == direct)
+ # Hard-coded to absolute criterion of 1e-10 for the linear model.
+ set Residual = 1e-6
+
+ # Number of Newton-Raphson iterations allowed (ignored if Model == linear)
+ set Max iterations Newton-Raphson = 10
+
+ # Relative displacement error tolerance for non-linear iteration (ignored if Model == linear)
+ set Tolerance displacement = 1.0e-6
+
+ # Relative force residual tolerance for non-linear iteration (ignored if Model == linear)
+ set Tolerance force = 1.0e-9
+end
+
+subsection precice configuration
+ # Cases: FSI3 or PF for perpendicular flap
+ set Scenario = PF
+
+ # Name of the precice configuration file
+ set precice config-file = ../precice-config.xml
+
+ # Name of the participant in the precice-config.xml file
+ set Participant name = Solid
+
+ # Name of the coupling mesh in the precice-config.xml file
+ set Mesh name = Solid-Mesh
+
+ # Name of the read data in the precice-config.xml file
+ set Read data name = Force
+
+ # Name of the write data in the precice-config.xml file
+ set Write data name = Displacement
+end
diff --git a/perpendicular-flap/solid-dealii/run.sh b/perpendicular-flap/solid-dealii/run.sh
new file mode 120000
index 000000000..3db351e72
--- /dev/null
+++ b/perpendicular-flap/solid-dealii/run.sh
@@ -0,0 +1 @@
+../../tools/run-dealii.sh
\ No newline at end of file
diff --git a/perpendicular-flap/solid-fenics/clean.sh b/perpendicular-flap/solid-fenics/clean.sh
new file mode 100755
index 000000000..3a8b4619d
--- /dev/null
+++ b/perpendicular-flap/solid-fenics/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_fenics .
diff --git a/perpendicular-flap/solid-fenics/precice-adapter-config-fsi-s.json b/perpendicular-flap/solid-fenics/precice-adapter-config-fsi-s.json
new file mode 100644
index 000000000..91a042b17
--- /dev/null
+++ b/perpendicular-flap/solid-fenics/precice-adapter-config-fsi-s.json
@@ -0,0 +1,9 @@
+{
+ "participant_name": "Solid",
+ "config_file_name": "../precice-config.xml",
+ "interface": {
+ "coupling_mesh_name": "Solid-Mesh",
+ "write_data_name": "Displacement",
+ "read_data_name": "Force"
+ }
+}
diff --git a/perpendicular-flap/solid-fenics/run.sh b/perpendicular-flap/solid-fenics/run.sh
new file mode 100755
index 000000000..15315c67d
--- /dev/null
+++ b/perpendicular-flap/solid-fenics/run.sh
@@ -0,0 +1,4 @@
+#!/bin/sh
+set -e -u
+
+python3 solid.py
diff --git a/FSI/flap_perp_2D/SU2-FEniCS/Solid/perp-flap.py b/perpendicular-flap/solid-fenics/solid.py
similarity index 91%
rename from FSI/flap_perp_2D/SU2-FEniCS/Solid/perp-flap.py
rename to perpendicular-flap/solid-fenics/solid.py
index a57f922a3..66bcb3a62 100644
--- a/FSI/flap_perp_2D/SU2-FEniCS/Solid/perp-flap.py
+++ b/perpendicular-flap/solid-fenics/solid.py
@@ -5,7 +5,7 @@
from ufl import nabla_div
import numpy as np
import matplotlib.pyplot as plt
-from fenicsadapter import Adapter
+from fenicsprecice import Adapter
from enum import Enum
@@ -17,7 +17,7 @@ def clamped_boundary(x, on_boundary):
def neumann_boundary(x, on_boundary):
"""
determines whether a node is on the coupling boundary
-
+
"""
return on_boundary and ((abs(x[1] - 1) < tol) or abs(abs(x[0]) - W / 2) < tol)
@@ -27,7 +27,7 @@ def neumann_boundary(x, on_boundary):
H = 1
W = 0.1
rho = 3000
-E = 1000000.0
+E = 4000000
nu = 0.3
mu = Constant(E / (2.0 * (1.0 + nu)))
@@ -35,8 +35,8 @@ def neumann_boundary(x, on_boundary):
lambda_ = Constant(E * nu / ((1.0 + nu) * (1.0 - 2.0 * nu)))
# create Mesh
-n_x_Direction = 2
-n_y_Direction = 13
+n_x_Direction = 4
+n_y_Direction = 26
mesh = RectangleMesh(Point(-W / 2, 0), Point(W / 2, H), n_x_Direction, n_y_Direction)
h = Constant(H / n_y_Direction)
@@ -59,9 +59,6 @@ def neumann_boundary(x, on_boundary):
v_n = Function(V)
a_n = Function(V)
-# Function to calculate displacement Deltas
-u_delta = Function(V)
-u_ref = Function(V)
f_N_function = interpolate(Expression(("1", "0"), degree=1), V)
u_function = interpolate(Expression(("0", "0"), degree=1), V)
@@ -82,8 +79,8 @@ def neumann_boundary(x, on_boundary):
bc = DirichletBC(V, Constant((0, 0)), fixed_boundary)
# alpha method parameters
-alpha_m = Constant(0.2)
-alpha_f = Constant(0.4)
+alpha_m = Constant(0)
+alpha_f = Constant(0)
gamma = Constant(0.5 + alpha_f - alpha_m)
beta = Constant((gamma + 0.5)**2 / 4.)
@@ -171,10 +168,6 @@ def avg(x_old, x_new, alpha):
# parameters for Time-Stepping
t = 0.0
n = 0
-time = []
-u_tip = []
-time.append(0.0)
-u_tip.append(0.0)
E_ext = 0
displacement_out = File("Solid/FSI-S/u_fsi.pvd")
@@ -187,7 +180,6 @@ def avg(x_old, x_new, alpha):
if precice.is_action_required(precice.action_write_iteration_checkpoint()): # write checkpoint
precice.store_checkpoint(u_n, t, n)
- u_ref = u_n.copy()
# read data from preCICE and get a new coupling expression
read_data = precice.read_data()
@@ -210,8 +202,7 @@ def avg(x_old, x_new, alpha):
dt = Constant(np.min([precice_dt, fenics_dt]))
# Write new displacements to preCICE
- u_delta = project(u_np1 - u_ref, V)
- precice.write_data(u_delta)
+ precice.write_data(u_np1)
# Call to advance coupling, also returns the optimum time step value
precice_dt = precice.advance(dt(0))
@@ -232,15 +223,7 @@ def avg(x_old, x_new, alpha):
if n % 10 == 0:
displacement_out << (u_n, t)
- u_tip.append(u_n(0., 1.)[0])
- time.append(t)
-
# Plot tip displacement evolution
displacement_out << u_n
-plt.figure()
-plt.plot(time, u_tip)
-plt.xlabel("Time")
-plt.ylabel("Tip displacement")
-plt.show()
precice.finalize()
diff --git a/quickstart/README.md b/quickstart/README.md
new file mode 100644
index 000000000..10fb312c4
--- /dev/null
+++ b/quickstart/README.md
@@ -0,0 +1,90 @@
+---
+title: Quickstart
+permalink: quickstart.html
+keywords: tutorial, quickstart
+summary: "Install preCICE on Linux (e.g. via a Debian package) and couple an OpenFOAM fluid solver (using the OpenFOAM-preCICE adapter) with an example rigid body solver in C++."
+layout: "page"
+comments: false
+search: true
+sidebar: nil
+topnav: topnav
+toc: false
+---
+
+
+This is the first step you may want to try if you are new to preCICE: install preCICE and some solvers, and run a simple coupled case.
+
+To get a feeling what preCICE does, watch a [short presentation](https://www.youtube.com/watch?v=FCv2FNUvKA8), a [longer talk on the fundamentals](https://www.youtube.com/watch?v=9EDFlgfpGBs), or [click through a tutorial in your browser](http://run.precice.org/).
+
+## Installation
+
+1. Get and install preCICE. For Ubuntu 20.04 (Focal Fossa), this is pretty easy: [download](https://github.com/precice/precice/releases/latest) and install our binary package by clicking on it or using the following commands:
+ ```bash
+ wget https://github.com/precice/precice/releases/download/v2.2.0/libprecice2_2.2.0_focal.deb
+ sudo apt install ./libprecice2_2.2.0_focal.deb
+ ```
+ - Are you using something else? Just pick what suits you best on [this overview page](installation-overview.html).
+ - Facing any problems? [Ask for help](community-channels.html).
+2. We will use OpenFOAM here and in many of our tutorial cases, so [install OpenFOAM](adapter-openfoam-support.html):
+ ```bash
+ # Add the signing key, add the repository, update (check this):
+ wget -q -O - https://dl.openfoam.com/add-debian-repo.sh | sudo bash
+ # Install OpenFOAM v2012:
+ sudo apt-get install openfoam2012-dev
+ ```
+3. Download and install the [OpenFOAM-preCICE adapter](adapter-openfoam-get.html):
+ ```bash
+ git clone --branch=master --depth 1 https://github.com/precice/openfoam-adapter
+ cd openfoam-adapter
+ ./Allwmake
+ cd ..
+ ```
+4. Get the quickstart tutorial case:
+ ```bash
+ git clone --branch=master --depth 1 https://github.com/precice/tutorials.git
+ cd tutorials/quickstart
+ ```
+
+If you prefer to easily try everything in an isolated environment, you may prefer using our [demo virtual machine](installation-vm.html).
+
+## Case setup
+
+We will couple OpenFOAM with a C++ rigid body solver for fluid-structure interaction. The rigid body has only a single degree of freedom, namely the deflection angle of the flap in the channel. It is also fixed in the origin at (0,0) and the force exerted by the fluid on the rigid body structure causes an oscillatory rotation of the body. The simulation runs for 2.5 seconds.
+
+In order to gain more control over the rigid body oscillation, a rotational spring is applied at the rigid body origin. After 1.5 seconds we increase the spring constant by a factor of 8 to stabilize the coupled problem. Feel free to modify these parameters (directly in `rigid_body_solver.cpp`) and increase the simulation time (in `precice-config.xml`).
+
+
+
+## Building the rigid body solver
+
+Before starting the coupled simulation, the rigid body solver needs to be built using CMake. You can run the following commands from the `quickstart/` directory to build the `rigid_body_solver.cpp`
+```
+cd solid-cpp
+cmake . && make
+```
+
+## Running the coupled simulation
+
+You may run the two simulations in two different terminals and watch their output on the screen using `./run.sh` (or `./run.sh -parallel`, option only available for OpenFOAM) from inside the directory of each participant. You can cleanup the simulation using `./clean-tutorial.sh`.
+
+In serial, the simulation should take roughly 30 seconds to compute.
+
+## Visualizing the results
+
+You can visualize the simulation results of the `Fluid` participant using ParaView and loading the (empty) file `Fluid.foam`. The rigid body does not generate any readable output files, but the motion can be observed in the OpenFOAM data.
+
+In addition, one could visualize the coupling meshes, including the exchanged coupling data. preCICE generates the relevant files during the simulation and stores them in the directory `coupling-meshes`. In order to visualize the results, load the VTK files in ParaView and apply a `Glyph` filter. Depending on the specific ParaView version, you might additionally need to disable the `ScaleArray` option by selecting `No scale array`, since the exchanged data might be inappropriate for a scaling operation. You can further add a `Warp By Vector` filter with `Displacement` to deform the coupling data. The result should look as follows:
+
+
+
+## What's next?
+
+To become a preCICE pro:
+
+* Get an overview of the [preCICE docs](docs.html).
+* See what users talk about in the [preCICE forum](https://precice.discourse.group/).
+* Run [tutorials with other coupled solvers](tutorials.html).
+* Watch some [preCICE videos](https://www.youtube.com/c/preCICECoupling/).
+* Meet our [community](community.html).
+* Find out how to [couple your own solver](couple-your-code-overview.html).
+* Tell us [your story](community-projects.html).
\ No newline at end of file
diff --git a/quickstart/clean-tutorial.sh b/quickstart/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/quickstart/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/U b/quickstart/fluid-openfoam/0/U
similarity index 77%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/U
rename to quickstart/fluid-openfoam/0/U
index 9bfbc4ea3..69dfcf932 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0/U
+++ b/quickstart/fluid-openfoam/0/U
@@ -3,44 +3,52 @@ FoamFile
version 2.0;
format ascii;
class volVectorField;
- location "0";
object U;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 1 -1 0 0 0 0];
-internalField uniform (10 0 0);
+internalField uniform (0 0 0);
boundaryField
{
- inlet
- {
- type fixedValue;
- value $internalField;
- }
- outlet
- {
- type zeroGradient;
- }
+
flap
{
type movingWallVelocity;
value uniform (0 0 0);
}
- upperWall
+
+ top
{
type noSlip;
}
- lowerWall
+
+ bottom
{
type noSlip;
}
- frontAndBack
+
+ inlet
+ {
+ type fixedValue;
+ value uniform (1 0 0);
+ }
+
+ outlet
+ {
+ type zeroGradient;
+ }
+
+ front
+ {
+ type empty;
+ }
+ back
{
type empty;
}
}
-
// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/p b/quickstart/fluid-openfoam/0/p
similarity index 92%
rename from FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/p
rename to quickstart/fluid-openfoam/0/p
index 52e0fdef3..90e9358f4 100644
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/0/p
+++ b/quickstart/fluid-openfoam/0/p
@@ -13,11 +13,6 @@ internalField uniform 0;
boundaryField
{
- cylinder
- {
- type zeroGradient;
- }
-
flap
{
type zeroGradient;
diff --git a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement b/quickstart/fluid-openfoam/0/pointDisplacement
similarity index 90%
rename from FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
rename to quickstart/fluid-openfoam/0/pointDisplacement
index c107f3b65..e12eaa933 100644
--- a/FSI/flap_perp/OpenFOAM-deal.II/Fluid/0.orig/pointDisplacement
+++ b/quickstart/fluid-openfoam/0/pointDisplacement
@@ -31,17 +31,20 @@ boundaryField
value $internalField;
}
- upperWall
+ top
{
type slip;
}
- lowerWall
+ bottom
{
type slip;
}
-
- frontAndBack
+ front
+ {
+ type empty;
+ }
+ back
{
type empty;
}
diff --git a/quickstart/fluid-openfoam/clean.sh b/quickstart/fluid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/quickstart/fluid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict b/quickstart/fluid-openfoam/constant/dynamicMeshDict
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/constant/dynamicMeshDict
rename to quickstart/fluid-openfoam/constant/dynamicMeshDict
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/constant/transportProperties b/quickstart/fluid-openfoam/constant/transportProperties
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/constant/transportProperties
rename to quickstart/fluid-openfoam/constant/transportProperties
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/constant/turbulenceProperties b/quickstart/fluid-openfoam/constant/turbulenceProperties
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/constant/turbulenceProperties
rename to quickstart/fluid-openfoam/constant/turbulenceProperties
diff --git a/quickstart/fluid-openfoam/run.sh b/quickstart/fluid-openfoam/run.sh
new file mode 100755
index 000000000..c191b9e48
--- /dev/null
+++ b/quickstart/fluid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/quickstart/fluid-openfoam/system/blockMeshDict b/quickstart/fluid-openfoam/system/blockMeshDict
new file mode 100644
index 000000000..c8a955624
--- /dev/null
+++ b/quickstart/fluid-openfoam/system/blockMeshDict
@@ -0,0 +1,199 @@
+FoamFile
+{
+ version 2.0;
+ format ascii;
+ class dictionary;
+ object blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+scale 1;
+
+b -0.1; // z-back
+f 0.1; // z-front
+
+// Vertices
+X1 -0.2; // pre rigid body
+X2 0.0; // begin rigid body
+X3 0.2; // end rigid body
+X4 0.6; // wake
+
+Y1 -0.13; // distance to bottom
+Y2 -0.01; // half body height
+Y3 0.01; // half body height
+Y4 0.12; // distance to top
+
+// Blocks
+H1 12;
+H2 14;
+H3 20;
+
+V1 12;
+V2 2;
+V3 11;
+
+G3 4;
+
+vertices
+(
+ // X1 layer back
+ ($X1 $Y1 $b) // 0
+ ($X1 $Y2 $b)
+ ($X1 $Y3 $b)
+ ($X1 $Y4 $b)
+
+ // X1 layer front
+ ($X1 $Y1 $f) // 4
+ ($X1 $Y2 $f)
+ ($X1 $Y3 $f)
+ ($X1 $Y4 $f)
+
+ // X2 layer back
+ ($X2 $Y1 $b) // 8
+ ($X2 $Y2 $b)
+ ($X2 $Y3 $b)
+ ($X2 $Y4 $b)
+
+ // X2 layer front
+ ($X2 $Y1 $f) // 12
+ ($X2 $Y2 $f)
+ ($X2 $Y3 $f)
+ ($X2 $Y4 $f)
+
+ // X3 layer back
+ ($X3 $Y1 $b) // 16
+ ($X3 $Y2 $b)
+ ($X3 $Y3 $b)
+ ($X3 $Y4 $b)
+
+ // X3 layer front
+ ($X3 $Y1 $f) // 20
+ ($X3 $Y2 $f)
+ ($X3 $Y3 $f)
+ ($X3 $Y4 $f)
+
+ // X4 layer back
+ ($X4 $Y1 $b) // 24
+ ($X4 $Y2 $b)
+ ($X4 $Y3 $b)
+ ($X4 $Y4 $b)
+
+ // X4 layer front
+ ($X4 $Y1 $f) // 28
+ ($X4 $Y2 $f)
+ ($X4 $Y3 $f)
+ ($X4 $Y4 $f)
+
+);
+
+blocks
+(
+ // Block 0-3
+ hex ( 0 8 9 1 4 12 13 5) ($H1 $V1 1) simpleGrading (1 1 1)
+ hex ( 1 9 10 2 5 13 14 6) ($H1 $V2 1) simpleGrading (1 1 1)
+ hex ( 2 10 11 3 6 14 15 7) ($H1 $V3 1) simpleGrading (1 1 1)
+
+ // Block 4-6 \5
+ hex ( 8 16 17 9 12 20 21 13) ($H2 $V1 1) simpleGrading (1 1 1)
+ hex ( 10 18 19 11 14 22 23 15) ($H2 $V3 1) simpleGrading (1 1 1)
+
+ // Block 7-9
+ hex ( 16 24 25 17 20 28 29 21) ($H3 $V1 1) simpleGrading ($G3 1 1)
+ hex ( 17 25 26 18 21 29 30 22) ($H3 $V2 1) simpleGrading ($G3 1 1)
+ hex ( 18 26 27 19 22 30 31 23) ($H3 $V3 1) simpleGrading ($G3 1 1)
+
+);
+
+
+boundary
+(
+ back
+ {
+ type empty;
+ faces
+ (
+ (0 8 9 1)
+ (1 9 10 2)
+ (2 10 11 3)
+ (8 16 17 9)
+ (10 18 19 11)
+ (16 24 25 17)
+ (17 25 26 18)
+ (18 26 27 19)
+ );
+ }
+
+ front
+ {
+ type empty;
+ faces
+ (
+ (4 12 13 5)
+ (5 13 14 6)
+ (6 14 15 7)
+ (12 20 21 13)
+ (14 22 23 15)
+ (20 28 29 21)
+ (21 29 30 22)
+ (22 30 31 23)
+ );
+ }
+
+ inlet
+ {
+ type patch;
+ faces
+ (
+ (0 4 5 1)
+ (1 5 6 2)
+ (2 6 7 3)
+ );
+ }
+
+ outlet
+ {
+ type patch;
+ faces
+ (
+ (24 28 29 25)
+ (25 29 30 26)
+ (26 30 31 27)
+ );
+ }
+
+ flap
+ {
+ type wall;
+ faces
+ (
+ (9 13 14 10)
+ (9 17 21 13)
+ (10 18 22 14)
+ (18 22 21 17)
+ );
+ }
+
+ bottom
+ {
+ type wall;
+ faces
+ (
+ (0 8 12 4)
+ (8 16 20 12)
+ (16 24 28 20)
+ );
+ }
+
+ top
+ {
+ type wall;
+ faces
+ (
+ (3 11 15 7)
+ (11 19 23 15)
+ (19 27 31 23)
+ );
+ }
+);
+
+// ************************************************************************* //
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/controlDict b/quickstart/fluid-openfoam/system/controlDict
similarity index 70%
rename from FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/controlDict
rename to quickstart/fluid-openfoam/system/controlDict
index bfc387ea7..8a241d19b 100644
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/controlDict
+++ b/quickstart/fluid-openfoam/system/controlDict
@@ -13,19 +13,20 @@ FoamFile
application pimpleFoam; // OpenFOAM v1806, OpenFOAM 6, or newer
// application pimpleDyMFoam; // OpenFOAM v1712, OpenFOAM 5.x, or older
+
startFrom startTime;
startTime 0;
stopAt endTime;
-endTime 15;
+endTime 2.5;
-deltaT 0.002;
+deltaT 2.5e-2;
writeControl adjustableRunTime;
-writeInterval 100.;
+writeInterval 2.5e-2;
purgeWrite 0;
@@ -37,10 +38,21 @@ writeCompression off;
timeFormat general;
-timePrecision 12;
+timePrecision 8;
functions
{
+ forces
+ {
+ type forces;
+ libs ( "libforces.so" );
+ patches (flap);
+ rho rhoInf;
+ log true;
+ rhoInf 10;
+ CofR (0 0 0);
+ }
+
preCICE_Adapter
{
type preciceAdapterFunctionObject;
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/decomposeParDict b/quickstart/fluid-openfoam/system/decomposeParDict
similarity index 88%
rename from FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/decomposeParDict
rename to quickstart/fluid-openfoam/system/decomposeParDict
index c72a5d50e..dee82bfd0 100644
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Fluid/system/decomposeParDict
+++ b/quickstart/fluid-openfoam/system/decomposeParDict
@@ -8,12 +8,12 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
- numberOfSubdomains 6;
+ numberOfSubdomains 2;
method hierarchical;
hierarchicalCoeffs
{
- n (3 2 1);
+ n (2 1 1);
delta 0.001;
order xyz;
}
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/fvSchemes b/quickstart/fluid-openfoam/system/fvSchemes
similarity index 73%
rename from FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/fvSchemes
rename to quickstart/fluid-openfoam/system/fvSchemes
index b2d960d05..c784ff608 100644
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/fvSchemes
+++ b/quickstart/fluid-openfoam/system/fvSchemes
@@ -15,13 +15,13 @@ FoamFile
gradSchemes
{
- default Gauss linear;
+ default cellLimited Gauss linear 1;
}
divSchemes
{
default none;
- div(phi,U) bounded Gauss linearUpwind limited;
+ div(phi,U) Gauss linearUpwind grad(U);
div((nuEff*dev2(T(grad(U))))) Gauss linear;
}
@@ -39,15 +39,3 @@ FoamFile
{
default corrected;
}
-
- wallDist
- {
- method meshWave;
- }
-
- fluxRequired
- {
- default no;
- p ;
- Phi ;
- }
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/fvSolution b/quickstart/fluid-openfoam/system/fvSolution
similarity index 58%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/fvSolution
rename to quickstart/fluid-openfoam/system/fvSolution
index e93f49ff4..5592bdf82 100644
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/fvSolution
+++ b/quickstart/fluid-openfoam/system/fvSolution
@@ -13,24 +13,33 @@ solvers
p
{
solver GAMG;
- tolerance 1e-10;
- relTol 1e-6;
+ tolerance 1e-6;
+ relTol 1e-4;
smoother DICGaussSeidel;
}
pFinal
{
$p;
+ tolerance 1e-07;
relTol 0;
}
+ pcorr
+ {
+ solver GAMG;
+ tolerance 1e-5;
+ relTol 1e-3;
+ smoother GaussSeidel;
+ }
+
pcorrFinal
{
- $p;
+ $pcorr;
relTol 0;
}
- Phi
+ phi
{
$p;
}
@@ -39,8 +48,8 @@ solvers
{
solver smoothSolver;
smoother symGaussSeidel;
- tolerance 1e-10;
- relTol 1e-6;
+ tolerance 1e-7;
+ relTol 1e-5;
}
"(U|cellDisplacement)Final"
@@ -52,45 +61,24 @@ solvers
PIMPLE
{
+ nOuterCorrectors 10;
nCorrectors 2;
- nNonOrthogonalCorrectors 0;
- tolerance 1.0e-14;
- relTol 5e-3;
+ nNonOrthogonalCorrectors 1;
+ tolerance 1.0e-8;
+
+ correctPhi yes;
+ relTol 1e-4;
pisoTol 1e-6;
consistent true;
- nOuterCorrectors 50;
-
- // OpenFOAM (.com), OpenFOAM 5 or older (.org)
- /*
- residualControl
- {
- U
- {
- tolerance 5e-5;
- relTol 0;
- }
- p
- {
- tolerance 5e-4;
- relTol 0;
- }
- }
- */
-
- // OpenFOAM 6 (.org) or newer
- /*
- residualControl
- {
- U 5e-5;
- p 5e-4;
- }
- */
}
-
+PISO
+{
+ nNonOrthogonalCorrectors 1;
+}
potentialFlow
{
- nNonOrthogonalCorrectors 5;
+ nNonOrthogonalCorrectors 1;
}
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/preciceDict b/quickstart/fluid-openfoam/system/preciceDict
similarity index 55%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/preciceDict
rename to quickstart/fluid-openfoam/system/preciceDict
index ae6131716..c67f623a0 100644
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/preciceDict
+++ b/quickstart/fluid-openfoam/system/preciceDict
@@ -7,7 +7,7 @@ FoamFile
object preciceDict;
}
-preciceConfig "precice-config.xml";
+preciceConfig "../precice-config.xml";
participant Fluid;
@@ -17,33 +17,18 @@ interfaces
{
Interface1
{
- mesh Fluid-Mesh-Faces;
+ mesh Fluid-Mesh;
patches (flap);
locations faceCenters;
readData
(
+ Displacement
);
writeData
(
- Forces0
- );
- };
-
- Interface2
- {
- mesh Fluid-Mesh-Nodes;
- patches (flap);
- locations faceNodes;
-
- readData
- (
- Displacements0
- );
-
- writeData
- (
+ Force
);
};
};
@@ -51,4 +36,4 @@ interfaces
FSI
{
rho rho [1 -3 0 0 0 0 0] 1000;
-}
\ No newline at end of file
+}
diff --git a/quickstart/images/quickstart-result.png b/quickstart/images/quickstart-result.png
new file mode 100644
index 000000000..c1c9171eb
Binary files /dev/null and b/quickstart/images/quickstart-result.png differ
diff --git a/quickstart/images/quickstart-setup.png b/quickstart/images/quickstart-setup.png
new file mode 100644
index 000000000..37dec838d
Binary files /dev/null and b/quickstart/images/quickstart-setup.png differ
diff --git a/quickstart/plotDisplacement.sh b/quickstart/plotDisplacement.sh
new file mode 100755
index 000000000..f2f0840f2
--- /dev/null
+++ b/quickstart/plotDisplacement.sh
@@ -0,0 +1,8 @@
+#! /bin/bash
+gnuplot -p << EOF
+ set grid
+ set title 'Displacement of the rigid body tip'
+ set xlabel 'time [s]'
+ set ylabel 'y-displacement [m]'
+ plot "solid-cpp/precice-Solid-watchpoint-Flap-Tip.log" using 1:5 with lines notitle
+EOF
diff --git a/quickstart/precice-config.xml b/quickstart/precice-config.xml
new file mode 100644
index 000000000..e33d690a7
--- /dev/null
+++ b/quickstart/precice-config.xml
@@ -0,0 +1,69 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/quickstart/solid-cpp/CMakeLists.txt b/quickstart/solid-cpp/CMakeLists.txt
new file mode 100644
index 000000000..4024b0f9d
--- /dev/null
+++ b/quickstart/solid-cpp/CMakeLists.txt
@@ -0,0 +1,10 @@
+CMAKE_MINIMUM_REQUIRED(VERSION 3.10.2)
+SET(TARGET "rigid_body_solver")
+PROJECT(${TARGET} LANGUAGES CXX DESCRIPTION "rigid_body_solver")
+
+FIND_PACKAGE(precice REQUIRED CONFIG)
+ADD_EXECUTABLE(
+ ${TARGET}
+ ${TARGET}.cpp)
+
+TARGET_LINK_LIBRARIES(${TARGET} PRIVATE precice::precice)
diff --git a/quickstart/solid-cpp/clean.sh b/quickstart/solid-cpp/clean.sh
new file mode 100755
index 000000000..ccbff3c12
--- /dev/null
+++ b/quickstart/solid-cpp/clean.sh
@@ -0,0 +1,7 @@
+#bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+rm -rfv coupling-meshes
+clean_precice_logs .
diff --git a/quickstart/solid-cpp/rigid_body_solver.cpp b/quickstart/solid-cpp/rigid_body_solver.cpp
new file mode 100644
index 000000000..e0af5aefc
--- /dev/null
+++ b/quickstart/solid-cpp/rigid_body_solver.cpp
@@ -0,0 +1,256 @@
+#include
+#include
+#include
+#include
+
+using Vector = std::vector;
+
+struct DataContainer {
+ void save_old_state(const Vector &vertices,
+ const double &theta,
+ const double &theta_dot)
+ {
+ old_vertices = vertices;
+ old_theta = theta;
+ old_theta_dot = theta_dot;
+ }
+
+ void reload_old_state(Vector &vertices,
+ double &theta,
+ double &theta_dot) const
+ {
+ vertices = old_vertices;
+ theta = old_theta;
+ theta_dot = old_theta_dot;
+ }
+
+ Vector old_vertices;
+ double old_theta;
+ double old_theta_dot;
+};
+
+class Solver {
+public:
+ Solver(const double moment_of_inertia)
+ : moment_of_inertia(moment_of_inertia)
+ {
+ }
+
+ void
+ solve(const Vector &forces,
+ const Vector &initial_vertices,
+ Vector & vertices,
+ double & theta,
+ double & theta_dot,
+ const double spring_constant,
+ const double delta_t) const
+ {
+ // Compute total moment M = x^{n} x f^{n+1}
+ double moment = 0;
+ for (unsigned int i = 0; i < forces.size() / 2; ++i)
+ moment += vertices[2 * i] * forces[2 * i + 1] - vertices[2 * i + 1] * forces[2 * i];
+
+ // Store rigid body angle at the previous time level theta^{n}
+ const double theta_old = theta;
+
+ // Update angle to theta^{n+1} according to forward Euler method (simplified moment
+ // computation, which does not depend on the updated configuration). The contribution
+ // of the spring with strength k is discretized implicitly.
+ // theta^{n+1} = 1/ (1 - (k/I)*dt^2) * dt^2 * M / I + dt * \dot{theta}^{n} + theta^{n}
+ theta = (1. / (1 - (spring_constant / moment_of_inertia) * std::pow(delta_t, 2))) *
+ (std::pow(delta_t, 2) * moment / moment_of_inertia + delta_t * theta_dot + theta);
+
+ // Update angular velocity
+ // \dot{theta}^{n+1} = (theta^{n+1} - \dot{theta}^{n}) / dt
+ theta_dot = (theta - theta_old) / delta_t;
+
+ // Update vertices according to rigid body rotation using an out-of-plane (z-axis) rotation matrix
+ // x^{n+1} = x^{0} * cos(theta^{n+1}) + y^{0} * sin(theta^{n+1})
+ // y^{n+1} = -x^{0} * sin(theta^{n+1}) + y^{0} * cos(theta^{n+1})
+ for (uint i = 0; i < vertices.size() / 2; ++i) {
+ const double x_coord = initial_vertices[2 * i];
+ vertices[2 * i] = x_coord * std::cos(theta) + initial_vertices[2 * i + 1] * std::sin(theta);
+ vertices[2 * i + 1] = -x_coord * std::sin(theta) + initial_vertices[2 * i + 1] * std::cos(theta);
+ }
+ std::cout << "Theta: " << theta << " Theta dot: " << theta_dot << " Moment: " << moment << " Spring force: " << spring_constant * theta << std::endl;
+ }
+
+private:
+ const double moment_of_inertia;
+};
+
+int main()
+{
+ std::cout << "Rigid body: starting... \n";
+
+ // Configuration settings
+ const std::string config_file_name("../precice-config.xml");
+ const std::string solver_name("Solid");
+ const std::string mesh_name("Solid-Mesh");
+ const std::string data_write_name("Displacement");
+ const std::string data_read_name("Force");
+
+ // Mesh configuration
+ constexpr int vertical_refinement = 3;
+ constexpr int horizontal_refinement = 6;
+ // Rotation centre is at (0,0)
+ constexpr double length = 0.2;
+ constexpr double height = 0.02;
+
+ constexpr double density = 10000;
+ constexpr double spring_constant = -25;
+
+ // Time, where spring is stiffened
+ constexpr double switch_time = 1.5;
+ constexpr double stiffening_factor = 8;
+ //*******************************************************************************************//
+
+ // Derived quantities
+ constexpr int n_vertical_nodes = vertical_refinement * 2 + 1;
+ constexpr int n_horizontal_nodes = horizontal_refinement * 2 + 1;
+ // Substract shared nodes at each rigid body corner
+ constexpr int n_nodes = (n_vertical_nodes + n_horizontal_nodes - 2) * 2;
+ constexpr double mass = length * height * density;
+ // The moment of inertia is computed according to the rigid body configuration:
+ // a thin rectangular plate of height h, length l and mass m with axis of rotation
+ // at the end of the plate: I = (1/12)*m*(4*l^2+h^2)
+ constexpr double inertia_moment = (1. / 12) * mass * (4 * std::pow(length, 2) + std::pow(height, 2));
+ constexpr double delta_y = height / (n_vertical_nodes - 1);
+ constexpr double delta_x = length / (n_horizontal_nodes - 1);
+
+ // Create Solverinterface
+ precice::SolverInterface precice(solver_name,
+ config_file_name,
+ /*comm_rank*/ 0,
+ /*comm_size*/ 1);
+
+ const int mesh_id = precice.getMeshID(mesh_name);
+ const int dim = precice.getDimensions();
+ const int write_id = precice.getDataID(data_write_name, mesh_id);
+ const int read_id = precice.getDataID(data_read_name, mesh_id);
+
+ // Set up data structures
+ Vector forces(dim * n_nodes);
+ Vector vertices(dim * n_nodes);
+ Vector displacement(dim * n_nodes);
+ std::vector vertex_ids(n_nodes);
+ double theta_dot = 0.0;
+ double theta = 0.0;
+
+ {
+ // Define a boundary mesh
+ std::cout << "Rigid body: defining mesh: ";
+ std::cout << n_nodes << " nodes " << std::endl;
+
+ // upper y
+ // o---o---o---o---o---o---o
+ // |.......................|
+ // lower x o.......................o upper x
+ // |.......................|
+ // o---o---o---o---o---o---o
+ // lower y
+
+ // x planes
+ for (int i = 0; i < n_vertical_nodes; ++i) {
+ // lower x plane
+ vertices[dim * i] = 0.0; // fixed x
+ vertices[dim * i + 1] = -height * 0.5 + delta_y * i; // increasing y
+ // upper x plane
+ vertices[(2 * n_vertical_nodes) + dim * i] = length; // fixed x
+ vertices[(2 * n_vertical_nodes) + dim * i + 1] = vertices[dim * i + 1]; // increasing y
+ }
+
+ // y planes
+ const unsigned int of = 2 * dim * n_vertical_nodes; // static offset
+ // Lower and upper bounds are already included due to positive/negative x-planes
+ const unsigned int n_remaining_nodes = n_horizontal_nodes - 2;
+ for (unsigned int i = 0; i < n_remaining_nodes; ++i) {
+ // lower y plane
+ vertices[of + dim * i] = delta_x * (i + 1); // increasing x
+ vertices[of + dim * i + 1] = -height * 0.5; // fixed y
+ // upper y plane
+ vertices[of + (2 * n_remaining_nodes) + dim * i] = vertices[of + dim * i]; // increasing x
+ vertices[of + (2 * n_remaining_nodes) + dim * i + 1] = -vertices[of + dim * i + 1]; // fixed y
+ }
+ }
+ // Store the initial configuration
+ const Vector initial_vertices = vertices;
+
+ // Pass the vertices to preCICE
+ precice.setMeshVertices(mesh_id,
+ n_nodes,
+ vertices.data(),
+ vertex_ids.data());
+
+ // initialize the Solverinterface
+ double dt = precice.initialize();
+
+ // Compute the absolute displacement between the current vertices and the
+ // initial configuration. Here, this is mostly done for consistency reasons.
+ for (uint i = 0; i < displacement.size(); ++i)
+ displacement[i] = vertices[i] - initial_vertices[i];
+
+ // Set up a struct in order to store time dependent values
+ DataContainer data_container;
+ // Set up an object which handles the time integration
+ const Solver solver(inertia_moment);
+
+ // Start time loop
+ double time = 0;
+ while (precice.isCouplingOngoing()) {
+
+ std::cout << "Rigid body: t = " << time << "s \n";
+
+ std::cout << "Rigid body: reading initial data \n";
+ if (precice.isReadDataAvailable())
+ precice.readBlockVectorData(read_id,
+ n_nodes,
+ vertex_ids.data(),
+ forces.data());
+
+ // Store time dependent values
+ if (precice.isActionRequired(
+ precice::constants::actionWriteIterationCheckpoint())) {
+ data_container.save_old_state(vertices, theta, theta_dot);
+
+ precice.markActionFulfilled(
+ precice::constants::actionWriteIterationCheckpoint());
+ }
+
+ const double current_spring = time > switch_time ? spring_constant * stiffening_factor : spring_constant;
+ // Solve system
+ solver.solve(forces, initial_vertices, vertices, theta, theta_dot, current_spring, dt);
+
+ // Advance coupled system
+ // Compute absolute displacement with respect to the initial configuration
+ for (uint i = 0; i < displacement.size(); ++i)
+ displacement[i] = vertices[i] - initial_vertices[i];
+
+ std::cout << "Rigid body: writing coupling data \n";
+ if (precice.isWriteDataRequired(dt))
+ precice.writeBlockVectorData(write_id,
+ n_nodes,
+ vertex_ids.data(),
+ displacement.data());
+
+ std::cout << "Rigid body: advancing in time\n";
+ dt = precice.advance(dt);
+
+ // Reload time dependent values
+ if (precice.isActionRequired(
+ precice::constants::actionReadIterationCheckpoint())) {
+ data_container.reload_old_state(vertices, theta, theta_dot);
+
+ precice.markActionFulfilled(
+ precice::constants::actionReadIterationCheckpoint());
+ }
+
+ // Increment time in case the time window has been completed
+ if (precice.isTimeWindowComplete())
+ time += dt;
+ }
+
+ std::cout << "Rigid body: closing...\n";
+
+ return 0;
+}
diff --git a/quickstart/solid-cpp/run.sh b/quickstart/solid-cpp/run.sh
new file mode 100755
index 000000000..60b4fd3eb
--- /dev/null
+++ b/quickstart/solid-cpp/run.sh
@@ -0,0 +1,9 @@
+#!/bin/sh
+set -e -u
+
+solver=./rigid_body_solver
+if [ -f "${solver}" ]; then
+ ${solver}
+else
+ echo "Unable to locate the executable ${solver}. Have a look at the README for building instructions."
+fi
diff --git a/tools/check-size.sh b/tools/check-size.sh
new file mode 100755
index 000000000..9c0300c04
--- /dev/null
+++ b/tools/check-size.sh
@@ -0,0 +1,42 @@
+#!/bin/bash
+# Run this script at the root of the repository to check the size of images
+
+CODE=0
+MAXIMUMSIZE=250
+MAXIMUMGIFSIZE=2200
+
+RED='\033[0;31m'
+NOCOLOR='\033[0m'
+
+# Check tutorials
+IGNORE="tools"
+tutorials=$(find . -maxdepth 1 -type d -not -name ".*" | grep -vE $IGNORE | sed "s/^.\///")
+
+echo "Limit for regular images: "${MAXIMUMSIZE}" kb"
+echo "Limit for gifs: "${MAXIMUMGIFSIZE}" kb"
+# For all tutorials do
+for tutorial in $tutorials; do
+ images=$(find ./"${tutorial}"/images -type f 2> /dev/null | sed "s/^.\///")
+ for img in $images; do
+ actualsize=$(du -k "$img" | cut -f 1)
+ # Check gifs
+ if [[ "${img}" == *.gif ]]; then
+ if [ "${actualsize}" -ge "${MAXIMUMGIFSIZE}" ]; then
+ echo -e "$img:$RED $actualsize kb exceeds the limit of $MAXIMUMGIFSIZE kb. $NOCOLOR"
+ CODE=1
+ else
+ echo -e "$img: $actualsize kb (Ok)."
+ fi
+ else
+ if [ "${actualsize}" -ge "${MAXIMUMSIZE}" ]; then
+ echo -e "$img:$RED $actualsize kb exceeds the limit of $MAXIMUMSIZE kb. $NOCOLOR"
+ CODE=1
+ else
+ echo -e "$img: $actualsize kb (Ok)."
+ fi
+ fi
+ done
+done
+
+[ ! "$CODE" -eq "0" ] && echo "There have been errors"
+exit $CODE
diff --git a/tools/check.sh b/tools/check.sh
new file mode 100755
index 000000000..ef3325d1b
--- /dev/null
+++ b/tools/check.sh
@@ -0,0 +1,74 @@
+#!/bin/bash
+# Run this script at the root of the repository to check images and permalinks
+
+CODE=0
+
+# Check tutorials
+IGNORE="tools|quickstart"
+tutorials=$(find -maxdepth 1 -type d -not -name ".*" | grep -vE $IGNORE | sed "s/^.\///")
+
+for tutorial in $tutorials; do
+ # Check permalinks
+ docs=$(find ./$tutorial -maxdepth 1 -type f -name "*.md" | xargs grep -l "permalink:" | sed "s/^.\///")
+ for doc in $docs; do
+ link=$(grep "permalink:" $doc | sed "s/permalink: \+//")
+ prefix="tutorials-$tutorial"
+
+ if ! [[ $link =~ ^$prefix ]]; then
+ echo "$doc: error: wrong permalink"
+ echo "$doc: note: permalink \"$link\" does not start with \"$prefix\""
+ CODE=1
+ else
+ echo "$doc: info: correct permalink"
+ echo "$doc: note: permalink is \"$link\""
+ fi
+ echo
+ done
+
+ images=$(find ./$tutorial/images -type f 2> /dev/null | sed "s/^.\///")
+ prefix="tutorials-$tutorial-"
+ for img in $images; do
+ if ! [[ $img =~ ^$tutorial/images/$prefix ]]; then
+ echo "$img: error: wrong filename"
+ echo "$img: note: expected prefix \"$prefix\""
+ CODE=1
+ else
+ echo "$img: info: correct filename"
+ fi
+ echo
+ done
+done
+
+# Check quickstart
+docs=$(find ./quickstart -maxdepth 1 -type f -name "*.md" | xargs grep -l "permalink:" | sed "s/^.\///")
+for doc in $docs; do
+ link=$(grep "permalink:" $doc | sed "s/permalink: \+//")
+ prefix="quickstart"
+
+ if ! [[ $link =~ ^$prefix ]]; then
+ echo "$doc: error: wrong permalink"
+ echo "$doc: note: permalink \"$link\" does not start with \"$prefix\""
+ CODE=1
+ else
+ echo "$doc: info: correct permalink"
+ echo "$doc: note: permalink is \"$link\""
+ fi
+ echo
+done
+
+images=$(find ./quickstart/images -type f 2> /dev/null | sed "s/^.\///")
+prefix="quickstart-"
+for img in $images; do
+ if ! [[ $img =~ ^quickstart/images/$prefix ]]; then
+ echo "$img: error: wrong filename"
+ echo "$img: note: expected prefix \"$prefix\""
+ CODE=1
+ else
+ echo "$img: info: correct filename"
+ fi
+ echo
+done
+
+
+[ ! "$CODE" -eq "0" ] && echo "There have been errors"
+exit $CODE
diff --git a/tools/clean-tutorial-base.sh b/tools/clean-tutorial-base.sh
new file mode 100755
index 000000000..dd6fc4f26
--- /dev/null
+++ b/tools/clean-tutorial-base.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../tools/cleaning-tools.sh
+
+clean_tutorial .
diff --git a/tools/cleaning-tools.sh b/tools/cleaning-tools.sh
new file mode 100755
index 000000000..6908bf3cf
--- /dev/null
+++ b/tools/cleaning-tools.sh
@@ -0,0 +1,118 @@
+#!/bin/sh
+
+error() {
+ echo "Error: $1" >&2
+ exit 1
+}
+
+clean_tutorial() {
+ (
+ set -e -u
+ cd "$1"
+ echo "-- Cleaning up all cases in $(pwd)..."
+ rm -rfv ./precice-run/
+
+ for case in */; do
+ if [ "${case}" = images/ ]; then
+ continue
+ fi
+ (cd "${case}" && ./clean.sh || echo "No cleaning script in ${case} - skipping")
+ done
+ )
+}
+
+clean_precice_logs() {
+ (
+ set -e -u
+ cd "$1"
+ echo "---- Cleaning up preCICE logs in $(pwd)"
+ rm -fv ./precice-*-iterations.log \
+ ./precice-*-convergence.log \
+ ./precice-*-events.json \
+ ./precice-*-events-summary.log \
+ ./precice-postProcessingInfo.log \
+ ./precice-*-watchpoint-*.log \
+ ./precice-*-watchintegral-*.log \
+ ./core
+ )
+}
+
+clean_calculix() {
+ (
+ set -e -u
+ cd "$1"
+ echo "--- Cleaning up CalculiX case in $(pwd)"
+ rm -fv ./*.cvg ./*.dat ./*.frd ./*.sta ./*.12d spooles.out dummy
+ clean_precice_logs .
+ )
+}
+
+clean_codeaster() {
+ (
+ set -e -u
+ cd "$1"
+ echo "--- Cleaning up code_aster case in $(pwd)"
+ rm -fv ./*.mess ./*.resu ./*.rmed
+ rm -rfv ./REPE_OUT/*
+ clean_precice_logs .
+ )
+}
+
+clean_dealii() {
+ (
+ set -e -u
+ cd "$1"
+ echo "--- Cleaning up deal.II case in $(pwd)"
+ rm -rfv ./dealii-output/
+ clean_precice_logs .
+ )
+}
+
+clean_fenics() {
+ (
+ set -e -u
+ cd "$1"
+ echo "--- Cleaning up FEniCS case in $(pwd)"
+ rm -fv ./*.pvd spooles.out FSI-S/*
+ rm -rfv ./out/
+ rm -rfv ./preCICE-output/
+ clean_precice_logs .
+ )
+}
+
+clean_nutils() {
+ (
+ set -e -u
+ cd "$1"
+ echo "--- Cleaning up Nutils case in $(pwd)"
+ rm -fv ./*.vtk
+ rm -rfv ./preCICE-output/
+ clean_precice_logs .
+ )
+}
+
+clean_openfoam() {
+ (
+ set -e -u
+ cd "$1"
+ echo "--- Cleaning up OpenFOAM case in $(pwd)"
+ if [ -n "${WM_PROJECT:-}" ] || error "No OpenFOAM environment is active."; then
+ # shellcheck disable=SC1090 # This is an OpenFOAM file which we don't need to check
+ . "${WM_PROJECT_DIR}/bin/tools/CleanFunctions"
+ cleanCase
+ rm -rfv 0/uniform/functionObjects/functionObjectProperties
+ fi
+ rm -rfv ./preCICE-output/
+ clean_precice_logs .
+ )
+}
+
+clean_su2() {
+ (
+ set -e -u
+ cd "$1"
+ echo "--- Cleaning up SU2 case in $(pwd)"
+ rm -fv ./restart_flow_*.dat forces_breakdown.dat ./surface_flow_*.csv ./flow_*.vtk ./history_*.vtk
+ clean_precice_logs .
+ )
+}
diff --git a/tools/openfoam-remove-empty-dirs.sh b/tools/openfoam-remove-empty-dirs.sh
new file mode 100755
index 000000000..44427cf8c
--- /dev/null
+++ b/tools/openfoam-remove-empty-dirs.sh
@@ -0,0 +1,25 @@
+#! /bin/sh
+
+openfoam_remove_empty_dirs() {
+ (
+ set -e -u
+ echo "Looking for any time directories without results (e.g. stray functionObjectProperties files, see openfoam-adapter issue #26 on GitHub)..."
+
+ for f in [0-9]* [0-9]*.[0-9]*; do
+ if ! [ -f "${f}/U" ] && ! [ -f "${f}/T" ]; then
+ rm -rfv "${f}"
+ fi
+ done
+ if [ -d processor0 ]; then
+ for d in processor*; do
+ cd "${d}"
+ for f in [0-9]* [0-9]*.[0-9]*; do
+ if ! [ -f "${f}"/U ] && ! [ -f "${f}"/T ]; then
+ rm -rfv "${f}"
+ fi
+ done
+ cd ..
+ done
+ fi
+ )
+}
diff --git a/tools/run-dealii.sh b/tools/run-dealii.sh
new file mode 100755
index 000000000..318bb5143
--- /dev/null
+++ b/tools/run-dealii.sh
@@ -0,0 +1,36 @@
+#!/bin/sh
+set -e -u
+
+EXE=""
+
+for i in "$@"; do
+ case $i in
+ -e=* | --exec=*)
+ EXE="${i#*=}"
+ shift # past argument=value
+ ;;
+ *)
+ # unknown option
+ ;;
+ esac
+done
+
+# If the executable has been defined
+if [ -n "${EXE}" ]; then
+ "${EXE}" parameters.prm
+ exit 0
+fi
+
+EXE="elasticity"
+# If it is in the global path
+if [ -n "$(command -v "${EXE}")" ]; then
+ "${EXE}" parameters.prm
+ exit 0
+fi
+
+# If it has been copied to the local directory
+if test -f "elasticity"; then
+ ./"${EXE}" parameters.prm
+else
+ echo "Unable to find the executable ${EXE}. Either specify the executable explicitly (-e=/path/to/elasticity) or make it discoverable at runtime (e.g. export PATH)"
+fi
diff --git a/tools/run-openfoam.sh b/tools/run-openfoam.sh
new file mode 100755
index 000000000..e0667aa16
--- /dev/null
+++ b/tools/run-openfoam.sh
@@ -0,0 +1,15 @@
+#!/bin/sh
+set -e # Not setting -u as it gets triggered by the OpenFOAM RunFunctions
+
+# OpenFOAM run functions: getApplication, getNumberOfProcessors
+# shellcheck disable=SC1090 # This is an OpenFOAM file which we don't need to check
+. "${WM_PROJECT_DIR}/bin/tools/RunFunctions"
+solver=$(getApplication)
+if [ "${1:-}" = "-parallel" ]; then
+ procs=$(getNumberOfProcessors)
+ decomposePar -force
+ mpirun -np "${procs}" "${solver}" -parallel
+ reconstructPar
+else
+ ${solver}
+fi
diff --git a/turek-hron-fsi3/.gitignore b/turek-hron-fsi3/.gitignore
new file mode 100644
index 000000000..5515bdeb9
--- /dev/null
+++ b/turek-hron-fsi3/.gitignore
@@ -0,0 +1 @@
+solid-dealii/nonlinear_elasticity
diff --git a/turek-hron-fsi3/README.md b/turek-hron-fsi3/README.md
new file mode 100644
index 000000000..517d7148b
--- /dev/null
+++ b/turek-hron-fsi3/README.md
@@ -0,0 +1,91 @@
+---
+title: Turek Hron FSI3
+permalink: tutorials-turek-hron-fsi3.html
+keywords: OpenFOAM, deal.II, verification
+summary: The Turek-Hron FSI cases are well-established numerical benchmarks and, therefore, well suited for verification of preCICE itself and the used adapters. In this tutorial, we focus on the FSI3 case, which presents the most challenging case in terms of added mass. Please note that the meshes of this case are significantly finer than for other tutorials. Running the simulation might take a few hours. We do not recommend to run this tutorials as your first preCICE tutorial.
+---
+
+## Setup
+
+The setup is shown schematically here:
+
+
+
+For more information please refer to the original publication of the benchmark [1].
+
+## Available solvers
+
+Fluid participant:
+
+* OpenFOAM. For more information, have a look at the [OpenFOAM adapter documentation](adapter-openfoam-overview.html).
+
+{% include important.html content="For the parabolic inflow profile, this tutorial requires groovyBC. groovyBC is part of swak4Foam. You can find more explanations in [openfoamwiki.net](https://openfoamwiki.net/index.php/Contrib/swak4Foam) or get it from an [unofficial GitHub mirror](https://github.com/Unofficial-Extend-Project-Mirror/openfoam-extend-swak4Foam-dev.git). Please follow the building instructions there." %}
+
+Solid participant:
+
+* deal.II. For more information, have a look at the [deal.II adapter documentation](adapter-dealii-overview.html). This tutorial requires the nonlinear solid solver. Please copy the nonlinear solver executable to the `solid-dealii` folder or make it discoverable at runtime and update the `solid-dealii/run.sh` script.
+
+## Running the Simulation
+
+Open two separate terminals and start each participant by calling the respective run script.
+
+```
+cd fluid-openfoam
+./run.sh
+```
+and
+```
+cd solid-dealii
+./run.sh
+```
+
+You can also run OpenFOAM in parallel by `./run.sh -parallel`. The default setting here uses 25 MPI ranks. You can change this setting in `fluid-openfoam/system/decomposeParDict`.
+For older OpenFOAM versions, the solver name will differ. If you are using OpenFOAM v1712 / 5.x or older have a look in the `fluid-openfoam/system/controlDict` file and set the appropriate solver name.
+
+You may adjust the end time in the `precice-config.xml`, or interupt the execution earlier if you want.
+
+In the first few timesteps, many coupling iterations are required for convergence. Don't lose hope, things get better quickly.
+
+
+## Post-processing
+
+You can visualize the results of the coupled simulation using e.g. ParaView. Fluid results are in the OpenFOAM format and you may load the `fluid-openfoam.foam` file. Solid results are in VTK format.
+
+If you want to visualize both domains with ParaView, keep in mind that the deal.II solver writes results every few timesteps, while the OpenFOAM solver writes in reference to simulated time. For this reason, make sure that you use compatible write intervals. You may also need to convert the OpenFOAM results to VTK (with the command `foamToVTK`).
+
+There is an [known issue](https://github.com/precice/openfoam-adapter/issues/26) that leads to additional "empty" result directories when running with some OpenFOAM versions, leading to inconveniences during post-processing. At the end of `run.sh`, we call `openfoam_remove_empty_dirs` (provided by `tools/openfoam-remove-empty-dirs`) to delete the additional files before importing the results in ParaView.
+
+Moreover, as we defined a watchpoint at the flap tip (see `precice-config.xml`), we can plot it with gnuplot using the script `plot-displacement.sh`. The resulting graph shows the vertical (y) displacement of the tip of the flap.
+
+
+
+
+Before running the simulation again, you may want to cleanup any result files using the script `clean-tutorial.sh`.
+
+## Mesh refinement
+
+In `fluid-openfoam/system/`, we provide three different fluid meshes:
+* `blockMeshDict`: the default mesh with approximately 21k cells,
+* `blockMeshDict_refined`: a refined mesh with approximately 38k cells,
+* `blockMeshDict_double_refined`: a refined mesh with approximately 46k cells.
+
+If you want to use one of the two refined meshes, simply swap the `blockMeshDict`:
+```bash
+mv blockMeshDict blockMeshDict_original
+mv blockMeshDict_refined blockMeshDict
+```
+
+For the double-refined mesh, it is wisely to use local basis functions in the RBF data mapping method instead of global ones. You can use:
+
+```xml
+
+```
+
+You can find more information on RBF data mapping in the [documentation](configuration-mapping.html#radial-basis-function-mapping).
+
+## References
+
+[1] S. Turek, J. Hron, M. Madlik, M. Razzaq, H. Wobker, and J. Acker. Numerical simulation and benchmarking of a monolithic multigrid solver for fluid-structure interaction problems with application to hemodynamics. In H.-J. Bungartz, M. Mehl, and M. Schäfer, editors, Fluid Structure Interaction II: Modelling, Simulation, Optimization, page 432. Springer Berlin Heidelberg, 2010.
+
+{% include disclaimer.html content="This offering is not approved or endorsed by OpenCFD Limited, producer and distributor of the OpenFOAM software via www.openfoam.com, and owner of the OPENFOAM® and OpenCFD® trade marks." %}
diff --git a/turek-hron-fsi3/clean-tutorial.sh b/turek-hron-fsi3/clean-tutorial.sh
new file mode 120000
index 000000000..4713f5092
--- /dev/null
+++ b/turek-hron-fsi3/clean-tutorial.sh
@@ -0,0 +1 @@
+../tools/clean-tutorial-base.sh
\ No newline at end of file
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/U b/turek-hron-fsi3/fluid-openfoam/0/U
similarity index 72%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/U
rename to turek-hron-fsi3/fluid-openfoam/0/U
index d5a072d6e..c194d2abe 100644
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/U
+++ b/turek-hron-fsi3/fluid-openfoam/0/U
@@ -37,14 +37,11 @@ boundaryField
inlet
{
- // Time-varying inlet velocity
- type uniformFixedValue;
- uniformValue table
- (
- ( 0 ( 0 0 0 ) )
- ( 2. ( 2. 0 0 ) )
- ( 100 ( 2. 0 0 ) )
- );
+ // Time-varying parabolic inlet profile
+ type groovyBC;
+ variables "yp=pts().y;minY=min(yp);maxY=max(yp);para=-1.5*(maxY-pos().y)*(pos().y-minY)/(0.25*pow(maxY-minY,2))*normal();";
+ valueExpression "time()<2 ? 0.5*(1-cos(0.5*pi*time()))*2*para : 2*para";
+ value uniform (2 0 0);
}
outlet
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/p b/turek-hron-fsi3/fluid-openfoam/0/p
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/p
rename to turek-hron-fsi3/fluid-openfoam/0/p
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/pointDisplacement b/turek-hron-fsi3/fluid-openfoam/0/pointDisplacement
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/pointDisplacement
rename to turek-hron-fsi3/fluid-openfoam/0/pointDisplacement
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/vorticity b/turek-hron-fsi3/fluid-openfoam/0/vorticity
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/0.orig/vorticity
rename to turek-hron-fsi3/fluid-openfoam/0/vorticity
diff --git a/turek-hron-fsi3/fluid-openfoam/clean.sh b/turek-hron-fsi3/fluid-openfoam/clean.sh
new file mode 100755
index 000000000..c31d9fc76
--- /dev/null
+++ b/turek-hron-fsi3/fluid-openfoam/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_openfoam .
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/dynamicMeshDict b/turek-hron-fsi3/fluid-openfoam/constant/dynamicMeshDict
old mode 100755
new mode 100644
similarity index 100%
rename from FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/constant/dynamicMeshDict
rename to turek-hron-fsi3/fluid-openfoam/constant/dynamicMeshDict
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/constant/transportProperties b/turek-hron-fsi3/fluid-openfoam/constant/transportProperties
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/constant/transportProperties
rename to turek-hron-fsi3/fluid-openfoam/constant/transportProperties
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/constant/turbulenceProperties b/turek-hron-fsi3/fluid-openfoam/constant/turbulenceProperties
similarity index 100%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/constant/turbulenceProperties
rename to turek-hron-fsi3/fluid-openfoam/constant/turbulenceProperties
diff --git a/turek-hron-fsi3/fluid-openfoam/run.sh b/turek-hron-fsi3/fluid-openfoam/run.sh
new file mode 100755
index 000000000..c191b9e48
--- /dev/null
+++ b/turek-hron-fsi3/fluid-openfoam/run.sh
@@ -0,0 +1,8 @@
+#!/bin/sh
+set -e -u
+
+blockMesh
+touch fluid-openfoam.foam
+
+../../tools/run-openfoam.sh "$@"
+. ../../tools/openfoam-remove-empty-dirs.sh && openfoam_remove_empty_dirs
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/blockMeshDict b/turek-hron-fsi3/fluid-openfoam/system/blockMeshDict
similarity index 93%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/blockMeshDict
rename to turek-hron-fsi3/fluid-openfoam/system/blockMeshDict
index aec2990b0..c97b97f4f 100644
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/blockMeshDict
+++ b/turek-hron-fsi3/fluid-openfoam/system/blockMeshDict
@@ -7,28 +7,26 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-convertToMeters 1;
-
-// Geometry parameters
-f -0.005; // z-front
-b 0.005; // z-back
+f -0.1; // z-front
+b 0.1; // z-back
// Grid refinement parameters
-H1 13; // Nx first block
-H2 17; // Nx second block
-H3 34; // Nx third block
-H4 65; // Nx last block
-H5 9; // amount of cells above/below flap
-
-V1 13; // Ny first inlet/outlet block
-V2 17; // Ny second inlet block
-V3 10; // Amount of cells in radius
-V4 9; // Ny above/blow flap to back
-V5 14; // Ny top inlet/outlet block
-V6 2; // Ny after flap
+H1 21; // Nx first block
+H2 35; // Nx second block
+H3 78; // Nx third block flap in x
+H4 120; // Nx last block
+H5 14; // amount of cells above/below flap
+
+V1 22; // Ny first inlet/outlet block: Bottom wall to flap block
+V2 35; // Ny second inlet block
+V3 20; // Amount of cells in radius
+V4 14; // Ny above/blow flap to back
+V5 23; // Ny top inlet/outlet block: Top wall to flap block
+V6 5; // Ny after flap
GR 2.5; // Circular mesh gradient
-GO 8; // Outlet grading
+GO 11.5; // Outlet grading
+
vertices
(
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/blockMeshDict b/turek-hron-fsi3/fluid-openfoam/system/blockMeshDict_double_refined
similarity index 93%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/blockMeshDict
rename to turek-hron-fsi3/fluid-openfoam/system/blockMeshDict_double_refined
index aec2990b0..95769ff3e 100644
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/blockMeshDict
+++ b/turek-hron-fsi3/fluid-openfoam/system/blockMeshDict_double_refined
@@ -7,28 +7,27 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-convertToMeters 1;
-
// Geometry parameters
-f -0.005; // z-front
-b 0.005; // z-back
+f -0.1; // z-front
+b 0.1; // z-back
// Grid refinement parameters
-H1 13; // Nx first block
-H2 17; // Nx second block
-H3 34; // Nx third block
-H4 65; // Nx last block
-H5 9; // amount of cells above/below flap
-
-V1 13; // Ny first inlet/outlet block
-V2 17; // Ny second inlet block
-V3 10; // Amount of cells in radius
-V4 9; // Ny above/blow flap to back
-V5 14; // Ny top inlet/outlet block
-V6 2; // Ny after flap
+H1 34; // Nx first block
+H2 50; // Nx second block
+H3 125; // Nx third block flap in x
+H4 150; // Nx last block
+H5 25; // amount of cells above/below flap
+
+V1 34; // Ny first inlet/outlet block: Wall to flap block
+V2 50; // Ny second inlet block
+V3 26; // Amount of cells in radius
+V4 25; // Ny above/blow flap to back
+V5 33; // Ny top inlet/outlet block: Wall to flap block
+V6 8; // Ny after flap
GR 2.5; // Circular mesh gradient
-GO 8; // Outlet grading
+GO 11; // Outlet grading
+
vertices
(
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/blockMeshDict b/turek-hron-fsi3/fluid-openfoam/system/blockMeshDict_refined
similarity index 93%
rename from FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/blockMeshDict
rename to turek-hron-fsi3/fluid-openfoam/system/blockMeshDict_refined
index 24eb36623..984148a8e 100644
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/blockMeshDict
+++ b/turek-hron-fsi3/fluid-openfoam/system/blockMeshDict_refined
@@ -7,29 +7,28 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-convertToMeters 1;
-
// Geometry parameters
-f -0.5; // z-front
-b 0.5; // z-back
+f -0.1; // z-front
+b 0.1; // z-back
// Grid refinement parameters
-H1 13; // Nx first block
-H2 17; // Nx second block
-H3 34; // Nx third block
-H4 65; // Nx last block
-H5 9; // amount of cells above/below flap
-
-V1 13; // Ny first inlet/outlet block
-V2 17; // Ny second inlet block
-V3 10; // Amount of cells in radius
-V4 9; // Ny above/blow flap to back
-V5 14; // Ny top inlet/outlet block
-V6 2; // Ny after flap
+H1 34; // Nx first block
+H2 45; // Nx second block
+H3 88; // Nx third block flap in x
+H4 130; // Nx last block
+H5 24; // amount of cells above/below flap
+
+V1 34; // Ny first inlet/outlet block: Wall to flap block
+V2 45; // Ny second inlet block
+V3 26; // Amount of cells in radius
+V4 24; // Ny above/blow flap to back
+V5 37; // Ny top inlet/outlet block: Wall to flap block
+V6 5; // Ny after flap
GR 2.5; // Circular mesh gradient
GO 8; // Outlet grading
+
vertices
(
// Block 0
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/controlDict b/turek-hron-fsi3/fluid-openfoam/system/controlDict
similarity index 70%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/controlDict
rename to turek-hron-fsi3/fluid-openfoam/system/controlDict
index 8694980dc..9ee3e3816 100644
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/controlDict
+++ b/turek-hron-fsi3/fluid-openfoam/system/controlDict
@@ -13,15 +13,17 @@ FoamFile
application pimpleFoam; // OpenFOAM v1806, OpenFOAM 6, or newer
// application pimpleDyMFoam; // OpenFOAM v1712, OpenFOAM 5.x, or older
+libs ( "libgroovyBC.so" ) ;
+
startFrom startTime;
startTime 0;
stopAt endTime;
-endTime 25;
+endTime 15;
-deltaT 0.001;
+deltaT 1e-3;
writeControl adjustableRunTime;
@@ -37,10 +39,21 @@ writeCompression off;
timeFormat general;
-timePrecision 12;
+timePrecision 8;
functions
{
+ forces
+ {
+ type forces;
+ libs ( "libforces.so" );
+ patches (cylinder flap);
+ rho rhoInf;
+ log true;
+ rhoInf 1000;
+ CofR (0 0 0);
+ }
+
preCICE_Adapter
{
type preciceAdapterFunctionObject;
diff --git a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/decomposeParDict b/turek-hron-fsi3/fluid-openfoam/system/decomposeParDict
similarity index 88%
rename from FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/decomposeParDict
rename to turek-hron-fsi3/fluid-openfoam/system/decomposeParDict
index c72a5d50e..59d2ad529 100644
--- a/FSI/cylinderFlap/OpenFOAM-CalculiX/Fluid/system/decomposeParDict
+++ b/turek-hron-fsi3/fluid-openfoam/system/decomposeParDict
@@ -8,12 +8,12 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
- numberOfSubdomains 6;
+ numberOfSubdomains 25;
method hierarchical;
hierarchicalCoeffs
{
- n (3 2 1);
+ n (5 5 1);
delta 0.001;
order xyz;
}
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/fvSchemes b/turek-hron-fsi3/fluid-openfoam/system/fvSchemes
similarity index 73%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/fvSchemes
rename to turek-hron-fsi3/fluid-openfoam/system/fvSchemes
index b2d960d05..d95144988 100644
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/fvSchemes
+++ b/turek-hron-fsi3/fluid-openfoam/system/fvSchemes
@@ -15,13 +15,13 @@ FoamFile
gradSchemes
{
- default Gauss linear;
+ default cellLimited Gauss linear 1;
}
divSchemes
{
default none;
- div(phi,U) bounded Gauss linearUpwind limited;
+ div(phi,U) Gauss linearUpwind grad(U);
div((nuEff*dev2(T(grad(U))))) Gauss linear;
}
@@ -39,15 +39,3 @@ FoamFile
{
default corrected;
}
-
- wallDist
- {
- method meshWave;
- }
-
- fluxRequired
- {
- default no;
- p ;
- Phi ;
- }
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/fvSolution b/turek-hron-fsi3/fluid-openfoam/system/fvSolution
similarity index 64%
rename from FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/fvSolution
rename to turek-hron-fsi3/fluid-openfoam/system/fvSolution
index 886a252ec..d559f7d2f 100644
--- a/FSI/cylinderFlap_2D/OpenFOAM-FEniCS/Fluid/system/fvSolution
+++ b/turek-hron-fsi3/fluid-openfoam/system/fvSolution
@@ -13,24 +13,33 @@ solvers
p
{
solver GAMG;
- tolerance 1e-10;
- relTol 1e-6;
+ tolerance 1e-6;
+ relTol 1e-5;
smoother DICGaussSeidel;
}
pFinal
{
$p;
+ tolerance 1e-07;
relTol 0;
}
+ pcorr
+ {
+ solver GAMG;
+ tolerance 1e-5;
+ relTol 1e-4;
+ smoother GaussSeidel;
+ }
+
pcorrFinal
{
- $p;
+ $pcorr;
relTol 0;
}
- Phi
+ phi
{
$p;
}
@@ -39,7 +48,7 @@ solvers
{
solver smoothSolver;
smoother symGaussSeidel;
- tolerance 1e-10;
+ tolerance 1e-8;
relTol 1e-6;
}
@@ -52,45 +61,49 @@ solvers
PIMPLE
{
+ nOuterCorrectors 50;
nCorrectors 2;
- nNonOrthogonalCorrectors 0;
- tolerance 1.0e-14;
- relTol 5e-3;
+ nNonOrthogonalCorrectors 1;
+ tolerance 1.0e-12;
+
+ correctPhi yes;
+ relTol 1e-4;
pisoTol 1e-6;
consistent true;
- nOuterCorrectors 50;
-
// OpenFOAM (.com), OpenFOAM 5 or older (.org)
- /*
residualControl
{
- U
- {
- tolerance 5e-5;
- relTol 0;
- }
- p
- {
- tolerance 5e-4;
- relTol 0;
- }
+ U
+ {
+ tolerance 1e-5;
+ relTol 0;
+ }
+
+ p
+ {
+ tolerance 1e-5;
+ relTol 0;
+ }
}
- */
// OpenFOAM 6 (.org) or newer
/*
residualControl
{
- U 5e-5;
- p 5e-4;
+ U 1e-5;
+ p 1e-5;
}
*/
-}
+}
+PISO
+{
+ nNonOrthogonalCorrectors 1;
+}
potentialFlow
{
- nNonOrthogonalCorrectors 5;
+ nNonOrthogonalCorrectors 1;
}
diff --git a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/preciceDict b/turek-hron-fsi3/fluid-openfoam/system/preciceDict
similarity index 94%
rename from FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/preciceDict
rename to turek-hron-fsi3/fluid-openfoam/system/preciceDict
index bddc43321..2b2f761ed 100644
--- a/FSI/cylinderFlap/OpenFOAM-deal.II/Fluid/system/preciceDict
+++ b/turek-hron-fsi3/fluid-openfoam/system/preciceDict
@@ -7,7 +7,7 @@ FoamFile
object preciceDict;
}
-preciceConfig "precice-config.xml";
+preciceConfig "../precice-config.xml";
participant Fluid;
@@ -51,4 +51,4 @@ interfaces
FSI
{
rho rho [1 -3 0 0 0 0 0] 1000;
-}
\ No newline at end of file
+}
diff --git a/turek-hron-fsi3/images/tutorials-turek-hron-fsi3-setup.png b/turek-hron-fsi3/images/tutorials-turek-hron-fsi3-setup.png
new file mode 100644
index 000000000..26f3ff188
Binary files /dev/null and b/turek-hron-fsi3/images/tutorials-turek-hron-fsi3-setup.png differ
diff --git a/turek-hron-fsi3/images/tutorials-turek-hron-fsi3-tip-plot.png b/turek-hron-fsi3/images/tutorials-turek-hron-fsi3-tip-plot.png
new file mode 100644
index 000000000..ff4779890
Binary files /dev/null and b/turek-hron-fsi3/images/tutorials-turek-hron-fsi3-tip-plot.png differ
diff --git a/turek-hron-fsi3/plot-displacement.sh b/turek-hron-fsi3/plot-displacement.sh
new file mode 100755
index 000000000..3a48e606c
--- /dev/null
+++ b/turek-hron-fsi3/plot-displacement.sh
@@ -0,0 +1,9 @@
+#!/bin/sh
+gnuplot -p << EOF
+ set grid
+ set title 'y-displacement of the flap tip'
+ set xlabel 'time [s]'
+ set ylabel 'y-displacement [m]'
+ set linestyle 1 lt 2 lc 1 # red-dashed
+ plot "solid-dealii/precice-Solid-watchpoint-Flap-Tip.log" using 1:5 with lines notitle
+EOF
diff --git a/turek-hron-fsi3/precice-config.xml b/turek-hron-fsi3/precice-config.xml
new file mode 100644
index 000000000..cd39d7e5a
--- /dev/null
+++ b/turek-hron-fsi3/precice-config.xml
@@ -0,0 +1,76 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/turek-hron-fsi3/solid-dealii/clean.sh b/turek-hron-fsi3/solid-dealii/clean.sh
new file mode 100755
index 000000000..9ad81b8fb
--- /dev/null
+++ b/turek-hron-fsi3/solid-dealii/clean.sh
@@ -0,0 +1,6 @@
+#!/bin/sh
+set -e -u
+
+. ../../tools/cleaning-tools.sh
+
+clean_dealii .
diff --git a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm b/turek-hron-fsi3/solid-dealii/parameters.prm
similarity index 56%
rename from FSI/cylinderFlap_2D/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
rename to turek-hron-fsi3/solid-dealii/parameters.prm
index 303f42c05..b725e3707 100644
--- a/FSI/cylinderFlap_2D/OpenFOAM-deal.II/Solid/nonlinear_elasticity.prm
+++ b/turek-hron-fsi3/solid-dealii/parameters.prm
@@ -7,19 +7,16 @@ subsection Time
set End time = 15
# Time step size
- set Time step size = 0.002
+ set Time step size = 0.001
- # Output interval
- set Output interval = 100
+ # Write results every x timesteps
+ set Output interval = 100
+
+ # Output folder
+ set Output folder = dealii-output
end
subsection Discretization
- # Newmark beta
- set beta = 0.25
-
- # Newmark gamma
- set gamma = 0.5
-
# Polynomial degree of the FE system
set Polynomial degree = 4
end
@@ -32,31 +29,34 @@ subsection System properties
set Shear modulus = 2.0e6
# Density
- set rho = 1000
+ set rho = 1000
# Body forces x,y,z
set body forces = 0.0,0.0,0.0
end
-subsection Linear solver
- # Linear solver iterations (multiples of the system matrix size)
- set Max iteration multiplier = 1
-
- # Linear solver residual (scaled by residual norm)
- set Residual = 1e-6
+subsection Solver
+ # Structural model to be used: linear or neo-Hookean
+ set Model = neo-Hookean
# Linear solver: CG or Direct
set Solver type = Direct
-end
-subsection Nonlinear solver
- # Number of Newton-Raphson iterations allowed
+ # Max CG solver iterations (multiples of the system matrix size)
+ # In 2D, this value is best set at 2. In 3D, a value of 1 works fine.
+ set Max iteration multiplier = 1
+
+ # Relative drop criterion for CG solver residual (multiplied by residual norm, ignored if Model == linear or solver == direct)
+ # Hard-coded to absolute criterion of 1e-10 for the linear model.
+ set Residual = 1e-6
+
+ # Number of Newton-Raphson iterations allowed (ignored if Model == linear)
set Max iterations Newton-Raphson = 10
- # Displacement error tolerance
+ # Relative displacement error tolerance for non-linear iteration (ignored if Model == linear)
set Tolerance displacement = 1.0e-6
- # Force residual tolerance
+ # Relative force residual tolerance for non-linear iteration (ignored if Model == linear)
set Tolerance force = 1.0e-9
end
@@ -65,13 +65,13 @@ subsection precice configuration
set Scenario = FSI3
# Name of the precice configuration file
- set precice config-file = precice-config.xml
+ set precice config-file = ../precice-config.xml
# Name of the participant in the precice-config.xml file
set Participant name = Solid
# Name of the coupling mesh in the precice-config.xml file
- set Mesh name = Solid_mesh
+ set Mesh name = Solid-Mesh
# Name of the read data in the precice-config.xml file
set Read data name = Stress
diff --git a/turek-hron-fsi3/solid-dealii/run.sh b/turek-hron-fsi3/solid-dealii/run.sh
new file mode 120000
index 000000000..3db351e72
--- /dev/null
+++ b/turek-hron-fsi3/solid-dealii/run.sh
@@ -0,0 +1 @@
+../../tools/run-dealii.sh
\ No newline at end of file