diff --git a/blast/blUtils.py b/blast/blUtils.py index b23aa5731aceef3ad8c72cf669bf66306eedd955..4abbd09d970a495fab7926f3c245ba479ca13b48 100644 --- a/blast/blUtils.py +++ b/blast/blUtils.py @@ -89,6 +89,8 @@ def initBlast(iconfig, vconfig, iSolver='DART', task='analysis'): # Inviscid solver if iSolver == 'DART': from blast.interfaces.dart.blDartInterface import DartInterface as interface + elif iSolver == 'SU2': + from blast.interfaces.su2.SU2Interface import SU2Interface as interface else: raise RuntimeError(f"Solver {iSolver} currently not implemented") diff --git a/blast/interfaces/su2/SU2Interface.py b/blast/interfaces/su2/SU2Interface.py new file mode 100644 index 0000000000000000000000000000000000000000..4d04e1af3485b6104c14c458efc31c3cff143202 --- /dev/null +++ b/blast/interfaces/su2/SU2Interface.py @@ -0,0 +1,276 @@ +#!/usr/bin/env python3 +# -*- coding: utf-8 -*- + +# Copyright 2020 University of Liège +# +# Licensed under the Apache License, Version 2.0 (the "License"); +# you may not use this file except in compliance with the License. +# You may obtain a copy of the License at +# +# http://www.apache.org/licenses/LICENSE-2.0 +# +# Unless required by applicable law or agreed to in writing, software +# distributed under the License is distributed on an "AS IS" BASIS, +# WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. +# See the License for the specific language governing permissions and +# limitations under the License. + +# SU2 interface +# Paul Dechamps +import numpy as np + +from blast.interfaces.blSolversInterface import SolversInterface +import pysu2 + +class SU2Interface(SolversInterface): + def __init__(self, su2config, vconfig, task='analysis'): + filename = su2config.get('filename') + self.have_mpi, self.comm, self.status, self.myid = self.__setup_mpi() + self.solver = pysu2.CSinglezoneDriver(filename, 1, self.comm) + + self.wingMarkersToID = {key: i for i, key in enumerate(self.solver.GetMarkerTags())} + self.wingTags = su2config.get('wingTags') + print('SU2Interface::SU2 solver initialized for', task) + + SolversInterface.__init__(self, vconfig) + + def __setup_mpi(self): + import sys + from mpi4py import MPI + if 'mpi4py.MPI' in sys.modules: + have_mpi = True + comm = MPI.COMM_WORLD + status = MPI.Status() + myid = comm.Get_rank() + else: + have_mpi = False + comm = None + status = None + myid = 0 + return have_mpi, comm, status, myid + + def run(self): + self.comm.barrier() + # run solver + self.solver.Preprocess(0) + self.solver.Run() + self.solver.Postprocess() + # write outputs + self.solver.Monitor(0) + self.solver.Output(0) + self.comm.barrier() + return 1 + + def writeCp(self): + """ Write Cp distribution around the airfoil on file. + """ + pass + + def getCp(self): + cp = np.zeros((self.nPoints[0], 2)) + for i in range(len(self.iBnd[0].nodesCoord[:,0])): + cp[i, 0] = self.iBnd[0].nodesCoord[i,0] + cp[i, 1] = self.solver.GetVertexCp(int(self.bndMarkers[0]), int(self.iBnd[0].connectListNodes[i])) + return cp + + def save(self, writer): + pass + + def getAoA(self): + return self.solver.GetOutputValue('AOA') * np.pi/180 + + def getnDim(self): + return self.solver.GetNumberDimensions() + + def getnBodies(self): + return 1 + + def getSpan(self, bodyname): + return 1.0 + + def getBlowingTypes(self, bodyname): + return['wing'] + + def getMinf(self): + vel_x_idx = self.solver.GetPrimitiveIndices()["VELOCITY_X"] + vel_y_idx = self.solver.GetPrimitiveIndices()["VELOCITY_Y"] + sound_speed_idx = self.solver.GetPrimitiveIndices()["SOUND_SPEED"] + + nNodes_farfield = self.solver.GetNumberMarkerNodes(self.wingMarkersToID['farfield']) + + vel_x = np.zeros(nNodes_farfield) + vel_y = np.zeros(nNodes_farfield) + sound_speed = np.zeros(nNodes_farfield) + + for inode in range(nNodes_farfield): + nodeIndex = self.solver.GetMarkerNode(self.wingMarkersToID['farfield'], inode) + vel_x[inode] = self.solver.Primitives().Get(int(nodeIndex), vel_x_idx) + vel_y[inode] = self.solver.Primitives().Get(int(nodeIndex), vel_y_idx) + sound_speed[inode] = self.solver.Primitives().Get(int(nodeIndex), sound_speed_idx) + mach_farfield = np.sqrt(vel_x**2 + vel_y**2) / sound_speed + return np.mean(mach_farfield) + + def getCl(self): + return self.solver.GetOutputValue('LIFT') + + def getCd(self): + return self.solver.GetOutputValue('DRAG') + + def getCm(self): + return self.solver.Get_Mx() + + def getVerbose(self): + return 1 + + def reset(self): + pass + + def imposeInvBC(self, couplIter): + """ Extract the inviscid paramaters at the edge of the boundary layer + and use it as a boundary condition in the viscous solver. + + Params + ------ + - couplIter (int): Coupling iteration. + """ + print('primitive indices', self.solver.GetPrimitiveIndices()) + print('self.solver.MarkerPrimitives()', self.solver.MarkerPrimitives(self.wingMarkersToID['airfoil'])) + vel_x_idx = self.solver.GetPrimitiveIndices()["VELOCITY_X"] + vel_y_idx = self.solver.GetPrimitiveIndices()["VELOCITY_Y"] + sound_speed_idx = self.solver.GetPrimitiveIndices()["SOUND_SPEED"] + pressure_idx = self.solver.GetPrimitiveIndices()["PRESSURE"] + + vel_x = np.zeros(self.iBnd[0][0].nodesCoord.shape[0]) + vel_y = np.zeros(self.iBnd[0][0].nodesCoord.shape[0]) + sound_speed = np.zeros(self.iBnd[0][0].nodesCoord.shape[0]) + pressure = np.zeros(self.iBnd[0][0].nodesCoord.shape[0]) + + for inode, nodeIndex in enumerate(self.iBnd[0][0].nodesCoord[:,-1]): + vel_x[inode] = self.solver.Primitives().Get(int(nodeIndex), vel_x_idx) + vel_y[inode] = self.solver.Primitives().Get(int(nodeIndex), vel_y_idx) + sound_speed[inode] = self.solver.Primitives().Get(int(nodeIndex), sound_speed_idx) + pressure[inode] = self.solver.Primitives().Get(int(nodeIndex), pressure_idx) + print(f"Node {inode} - Velocity X: {vel_x[inode]}, Velocity Y: {vel_y[inode]}, Sound Speed: {sound_speed[inode]}, Pressure: {pressure[inode]}") + + mach = np.sqrt(vel_x**2 + vel_y**2) / sound_speed + import matplotlib + matplotlib.use('Agg') # Use the Agg backend for non-interactive plotting + from matplotlib import pyplot as plt + plt.figure() + plt.plot(self.iBnd[0][0].nodesCoord[:,0], mach, 'x') + plt.xlabel('X Coordinate') + plt.ylabel('pressure') + plt.title('pressure Distribution') + plt.savefig('pressure_distribution.png') # Save the plot as an image file + print('Plot saved as mach_number_distribution.png') + quit() + if couplIter == 0: + self.cp0 = self.getCp() + # Retreive parameters. + for n in range(2): + for iRow, row in enumerate(self.iBnd[n].connectListNodes): + row=int(row) + self.iBnd[n].V[iRow,:] = self.solver.GetVertexVelocity(self.bndMarkers[n], row) + self.iBnd[n].M[iRow] = self.solver.GetVertexMach(self.bndMarkers[n], row) + self.iBnd[n].Rho[iRow] = self.solver.GetVertexDensity(self.bndMarkers[n], row) + if self.iBnd[n].Rho[iRow] == 0: + self.iBnd[n].Rho[iRow] = 1 + self.setViscousSolver(couplIter) + + def imposeBlwVel(self): + """ Extract the solution of the viscous calculation (blowing velocity) + and use it as a boundary condition in the inviscid solver. + """ + if self.iBnd[0].connectListNodes[0] != self.iBnd[0].connectListNodes[-1]: + raise RuntimeError("List of connectivity is incorrect.") + + self.getBlowingBoundary() + # Impose blowing velocities. + for n in range(len(self.bndMarkers)): + if n == 0: + self.iBnd[n].blowingVel[0] = .5 * (self.iBnd[n].blowingVel[0] + self.iBnd[n].blowingVel[-1]) + self.iBnd[n].blowingVel = self.iBnd[n].blowingVel[self.iBnd[n].connectListElems[:-1].argsort()] + elif n == 1: + self.iBnd[1].blowingVel = np.insert(self.iBnd[1].blowingVel, 0, self.iBnd[0].blowingVel[0]) + self.iBnd[n].blowingVel = self.iBnd[n].blowingVel[self.iBnd[n].connectListElems.argsort()] + for iVertex in range(len(self.iBnd[n].blowingVel)-1): + self.solver.SetBlowing(self.bndMarkers[n], iVertex, self.iBnd[n].blowingVel[iVertex]) + + def getWing(self): + if self.getnDim() == 2: + self._getAirfoil(0) + elif self.getnDim() == 3: + self._getWing3D(0) + else: + raise RuntimeError('su2Interface::Incorrect number of dimensions.') + + def _getAirfoil(self, ibody): + """ Retreives the mesh used for SU2 Euler calculation. + Airfoil is already in seilig format (Upper TE -> Lower TE). + """ + # nodes = np.zeros((0,3)) + # for arfTag in self.wingTags: + # nodesOnSide = np.empty((self.solver.GetNumberMarkerNodes(self.wingMarkersToID[arfTag]),3)) + # for i in range(self.solver.GetNumberMarkerNodes(self.wingMarkersToID[arfTag])): + # vertex = self.solver.GetMarkerNode(self.wingMarkersToID[arfTag], i) + # nodesOnSide[i, :self.getnDim()] = self.solver.Coordinates().Get(vertex) + # nodesOnSide = np.flip(nodesOnSide, axis=0) + # nodes = np.row_stack((nodes, nodesOnSide)) + # # Avoid duplicated leading edge point + # if len(np.where(nodes[:,0] == np.min(nodes[:,0]))[0]) > 1: + # nodes = np.delete(nodes, np.where(nodes[:,0] == np.min(nodes[:,0]))[0][1], axis=0) + + elemsCoord = np.zeros((0,4)) + nodesCoord = np.zeros((0,4)) + for arfTag in self.wingTags: + nodesOnSide = np.empty((self.solver.GetNumberMarkerNodes(self.wingMarkersToID[arfTag]), 4)) + elemsCoordOnSide = np.zeros((self.solver.GetNumberMarkerElements(self.wingMarkersToID[arfTag]), 4)) + inod = 0 + for ielm in range(self.solver.GetNumberMarkerElements(self.wingMarkersToID[arfTag])): + nodesonelm = self.solver.GetMarkerElementNodes(self.wingMarkersToID[arfTag], ielm) + for n in nodesonelm: + if n not in nodesOnSide[:,-1]: + nodesOnSide[inod, :self.getnDim()] = self.solver.Coordinates().Get(n) + nodesOnSide[inod, -1] = n + inod += 1 + elemsCoordOnSide[ielm, :self.getnDim()] += self.solver.Coordinates().Get(n) + elemsCoordOnSide[ielm, :self.getnDim()] /= len(nodesonelm) + elemsCoordOnSide[ielm, -1] = self.solver.GetMarkerElementGlobalIndex(self.wingMarkersToID[arfTag], ielm) + + # Sort in ascending order of first column + nodesOnSide = nodesOnSide[nodesOnSide[:,0].argsort()] + elemsCoordOnSide = elemsCoordOnSide[elemsCoordOnSide[:,0].argsort()] + if arfTag == 'airfoil': + nodesOnSide = np.flip(nodesOnSide, axis=0) + elemsCoordOnSide = np.flip(elemsCoordOnSide, axis=0) + #elemsCoordOnSide = np.flip(elemsCoordOnSide, axis=0) + nodesCoord = np.row_stack((nodesCoord, nodesOnSide)) + elemsCoord = np.row_stack((elemsCoord, elemsCoordOnSide)) + + # Avoid duplicated leading edge point + if len(np.where(nodesCoord[:,0] == np.min(nodesCoord[:,0]))[0]) > 1: + nodesCoord = np.delete(nodesCoord, np.where(nodesCoord[:,0] == np.min(nodesCoord[:,0]))[0][1], axis=0) + + import matplotlib + matplotlib.use('Agg') # Use the Agg backend for non-interactive plotting + from matplotlib import pyplot as plt + plt.figure() + plt.plot(nodesCoord[:, 0], nodesCoord[:, 1], 'x--') + plt.plot(elemsCoord[:, 0], elemsCoord[:, 1], 'o') + plt.xlabel('X Coordinate') + plt.ylabel('Y Coordinate') + plt.title('Airfoil Nodes') + plt.savefig('airfoil_nodes.png') # Save the plot as an image file + print('Plot saved as airfoil_nodes.png') + + # Check that the airfoil has closed trailing edge + if np.any(nodesCoord[0, [0,self.getnDim()-1]] != nodesCoord[-1, [0,self.getnDim()-1]]): + raise RuntimeError('su2Interface::Airfoil has an open trailing edge.') + else: + print('Airfoil has closed trailing edge.') + + self.iBnd[ibody][0].initStructures(nodesCoord.shape[0], elemsCoord.shape[0]) + self.iBnd[ibody][0].nodesCoord = nodesCoord + self.iBnd[ibody][0].elemsCoord = elemsCoord + self.iBnd[ibody][0].setConnectList(np.array(nodesCoord[:,-1],dtype=int), + np.array(elemsCoord[:,-1],dtype=int)) diff --git a/blast/models/su2/n0012_su2.geo b/blast/models/su2/n0012_su2.geo new file mode 100644 index 0000000000000000000000000000000000000000..8582a2375fa92ad7ff359b21df432f948d23afbf --- /dev/null +++ b/blast/models/su2/n0012_su2.geo @@ -0,0 +1,383 @@ +/* Airfoil NACA0012 */ +// This file was generated automatically using geoFoils v1.0 (https://github.com/Paul-Dech/geoFoils) +// @date: 2025-01-07 15:28:07 +// @author: Paul Dechamps + +// Geometry +DefineConstant[ xLgt = { 5.0, Name "Domain length (x-dir)" } ]; +DefineConstant[ yLgt = { 5.0, Name "Domain length (y-dir)" } ]; + +// Mesh +DefineConstant[ growthRatio = { 1.5, Name "Growth Ratio" } ]; +DefineConstant[ msTe = { 0.01, Name "Airfoil TE mesh size" } ]; +DefineConstant[ msLe = { 0.01, Name "Airfoil LE mesh size" } ]; + +// Rotation +DefineConstant[ xRot = { 0.25, Name "Center of rotation" } ]; +DefineConstant[ angle = { 0*Pi/180, Name "Angle of rotation" } ]; +Geometry.AutoCoherence = 0; // Needed so that gmsh does not remove duplicate + +If (growthRatio == 1.0) + msF = msLe; +Else + n = Log(1 - (1 - growthRatio) * xLgt / msLe) / Log(growthRatio); + msF = msLe * growthRatio^(n - 1); +EndIf + +/************** + Geometry + **************/ +Te = 1; // trailing edge +Le = 151; // leading edge + +Point( 1 ) = { 1.0, -0.0, 0.0, msTe }; +Point( 2 ) = { 0.99989034173742, 1.566142976e-05, 0.0}; +Point( 3 ) = { 0.99956141504943, 6.262613794e-05, 0.0}; +Point( 4 ) = { 0.99901336421414, 0.00014083544147, 0.0}; +Point( 5 ) = { 0.99824642962475, 0.0002501917354, 0.0}; +Point( 6 ) = { 0.99726094768414, 0.00039055879171, 0.0}; +Point( 7 ) = { 0.99605735065724, 0.00056176217462, 0.0}; +Point( 8 ) = { 0.99463616648149, 0.00076358976946, 0.0}; +Point( 9 ) = { 0.99299801853525, 0.00099579242133, 0.0}; +Point( 10 ) = { 0.99114362536434, 0.00125808467902, 0.0}; +Point( 11 ) = { 0.9890738003669, 0.0015501456389, 0.0}; +Point( 12 ) = { 0.98678945143658, 0.00187161988278, 0.0}; +Point( 13 ) = { 0.98429158056432, 0.0022221185031, 0.0}; +Point( 14 ) = { 0.98158128339883, 0.00260122020822, 0.0}; +Point( 15 ) = { 0.97865974876603, 0.00300847250009, 0.0}; +Point( 16 ) = { 0.97552825814758, 0.00344339291591, 0.0}; +Point( 17 ) = { 0.97218818511874, 0.0039054703252, 0.0}; +Point( 18 ) = { 0.96864099474595, 0.00439416627328, 0.0}; +Point( 19 ) = { 0.96488824294413, 0.00490891636171, 0.0}; +Point( 20 ) = { 0.96093157579425, 0.00544913165641, 0.0}; +Point( 21 ) = { 0.9567727288213, 0.00601420011357, 0.0}; +Point( 22 ) = { 0.95241352623301, 0.00660348801398, 0.0}; +Point( 23 ) = { 0.94785588011971, 0.00721634139577, 0.0}; +Point( 24 ) = { 0.94310178961561, 0.00785208747637, 0.0}; +Point( 25 ) = { 0.93815334002193, 0.00851003605407, 0.0}; +Point( 26 ) = { 0.93301270189222, 0.00918948088016, 0.0}; +Point( 27 ) = { 0.92768213008025, 0.00988970099293, 0.0}; +Point( 28 ) = { 0.92216396275101, 0.01060996200508, 0.0}; +Point( 29 ) = { 0.91646062035505, 0.01134951733663, 0.0}; +Point( 30 ) = { 0.91057460456685, 0.01210760938604, 0.0}; +Point( 31 ) = { 0.90450849718747, 0.01288347063272, 0.0}; +Point( 32 ) = { 0.8982649590121, 0.01367632466478, 0.0}; +Point( 33 ) = { 0.89184672866292, 0.01448538712671, 0.0}; +Point( 34 ) = { 0.88525662138789, 0.01530986658219, 0.0}; +Point( 35 ) = { 0.87849752782588, 0.01614896528828, 0.0}; +Point( 36 ) = { 0.8715724127387, 0.01700187987791, 0.0}; +Point( 37 ) = { 0.86448431371071, 0.01786780194847, 0.0}; +Point( 38 ) = { 0.8572363398164, 0.01874591855516, 0.0}; +Point( 39 ) = { 0.84983167025668, 0.01963541260873, 0.0}; +Point( 40 ) = { 0.84227355296434, 0.02053546317813, 0.0}; +Point( 41 ) = { 0.83456530317943, 0.02144524569925, 0.0}; +Point( 42 ) = { 0.82671030199505, 0.02236393209232, 0.0}; +Point( 43 ) = { 0.81871199487434, 0.02329069079083, 0.0}; +Point( 44 ) = { 0.81057389013916, 0.02422468668617, 0.0}; +Point( 45 ) = { 0.80229955743119, 0.02516508099279, 0.0}; +Point( 46 ) = { 0.79389262614624, 0.02611103103947, 0.0}; +Point( 47 ) = { 0.78535678384222, 0.02706168999315, 0.0}; +Point( 48 ) = { 0.77669577462167, 0.02801620652246, 0.0}; +Point( 49 ) = { 0.7679133974895, 0.02897372440866, 0.0}; +Point( 50 ) = { 0.75901350468657, 0.02993338211239, 0.0}; +Point( 51 ) = { 0.75, 0.03089431230516, 0.0}; +Point( 52 ) = { 0.74087683705086, 0.03185564137496, 0.0}; +Point( 53 ) = { 0.73164801755993, 0.03281648891572, 0.0}; +Point( 54 ) = { 0.72231758959246, 0.03377596721082, 0.0}; +Point( 55 ) = { 0.71288964578254, 0.03473318072085, 0.0}; +Point( 56 ) = { 0.7033683215379, 0.03568722558628, 0.0}; +Point( 57 ) = { 0.69375779322605, 0.03663718915547, 0.0}; +Point( 58 ) = { 0.68406227634234, 0.03758214954874, 0.0}; +Point( 59 ) = { 0.67428602366091, 0.03852117526877, 0.0}; +Point( 60 ) = { 0.66443332336929, 0.03945332486788, 0.0}; +Point( 61 ) = { 0.65450849718747, 0.0403776466819, 0.0}; +Point( 62 ) = { 0.64451589847224, 0.04129317864062, 0.0}; +Point( 63 ) = { 0.63445991030763, 0.04219894816377, 0.0}; +Point( 64 ) = { 0.62434494358243, 0.04309397215141, 0.0}; +Point( 65 ) = { 0.61417543505533, 0.04397725707679, 0.0}; +Point( 66 ) = { 0.60395584540888, 0.04484779918912, 0.0}; +Point( 67 ) = { 0.59369065729286, 0.04570458483296, 0.0}; +Point( 68 ) = { 0.58338437335805, 0.04654659089014, 0.0}; +Point( 69 ) = { 0.57304151428121, 0.04737278534922, 0.0}; +Point( 70 ) = { 0.56266661678215, 0.04818212800662, 0.0}; +Point( 71 ) = { 0.55226423163383, 0.04897357130255, 0.0}; +Point( 72 ) = { 0.54183892166616, 0.0497460612939, 0.0}; +Point( 73 ) = { 0.53139525976466, 0.05049853876514, 0.0}; +Point( 74 ) = { 0.5209378268646, 0.05122994047724, 0.0}; +Point( 75 ) = { 0.51047120994168, 0.05193920055357, 0.0}; +Point( 76 ) = { 0.5, 0.05262525200057, 0.0}; +Point( 77 ) = { 0.48952879005832, 0.05328702835989, 0.0}; +Point( 78 ) = { 0.4790621731354, 0.05392346548752, 0.0}; +Point( 79 ) = { 0.46860474023534, 0.05453350345464, 0.0}; +Point( 80 ) = { 0.45816107833384, 0.05511608856324, 0.0}; +Point( 81 ) = { 0.44773576836617, 0.05567017546926, 0.0}; +Point( 82 ) = { 0.43733338321785, 0.05619472940438, 0.0}; +Point( 83 ) = { 0.42695848571879, 0.05668872848681, 0.0}; +Point( 84 ) = { 0.41661562664195, 0.05715116611079, 0.0}; +Point( 85 ) = { 0.40630934270714, 0.05758105340305, 0.0}; +Point( 86 ) = { 0.39604415459112, 0.05797742173437, 0.0}; +Point( 87 ) = { 0.38582456494467, 0.05833932527305, 0.0}; +Point( 88 ) = { 0.37565505641757, 0.05866584356678, 0.0}; +Point( 89 ) = { 0.36554008969237, 0.05895608413888, 0.0}; +Point( 90 ) = { 0.35548410152776, 0.05920918508399, 0.0}; +Point( 91 ) = { 0.34549150281253, 0.05942431764848, 0.0}; +Point( 92 ) = { 0.33556667663071, 0.05960068878005, 0.0}; +Point( 93 ) = { 0.32571397633909, 0.05973754363096, 0.0}; +Point( 94 ) = { 0.31593772365766, 0.0598341679995, 0.0}; +Point( 95 ) = { 0.30624220677395, 0.05988989069371, 0.0}; +Point( 96 ) = { 0.2966316784621, 0.05990408580221, 0.0}; +Point( 97 ) = { 0.28711035421746, 0.05987617485653, 0.0}; +Point( 98 ) = { 0.27768241040754, 0.05980562887012, 0.0}; +Point( 99 ) = { 0.26835198244007, 0.05969197023942, 0.0}; +Point( 100 ) = { 0.25912316294914, 0.05953477449294, 0.0}; +Point( 101 ) = { 0.25, 0.059333671875, 0.0}; +Point( 102 ) = { 0.24098649531343, 0.05908834875129, 0.0}; +Point( 103 ) = { 0.2320866025105, 0.05879854882451, 0.0}; +Point( 104 ) = { 0.22330422537833, 0.058464074149, 0.0}; +Point( 105 ) = { 0.21464321615778, 0.05808478593443, 0.0}; +Point( 106 ) = { 0.20610737385376, 0.05766060512952, 0.0}; +Point( 107 ) = { 0.19770044256881, 0.05719151277812, 0.0}; +Point( 108 ) = { 0.18942610986084, 0.05667755014088, 0.0}; +Point( 109 ) = { 0.18128800512566, 0.0561188185773, 0.0}; +Point( 110 ) = { 0.17328969800495, 0.05551547918403, 0.0}; +Point( 111 ) = { 0.16543469682057, 0.05486775218683, 0.0}; +Point( 112 ) = { 0.15772644703566, 0.05417591608471, 0.0}; +Point( 113 ) = { 0.15016832974332, 0.05344030654663, 0.0}; +Point( 114 ) = { 0.1427636601836, 0.05266131506196, 0.0}; +Point( 115 ) = { 0.13551568628929, 0.05183938734803, 0.0}; +Point( 116 ) = { 0.1284275872613, 0.05097502151884, 0.0}; +Point( 117 ) = { 0.12150247217412, 0.05006876602101, 0.0}; +Point( 118 ) = { 0.11474337861211, 0.04912121734409, 0.0}; +Point( 119 ) = { 0.10815327133708, 0.04813301751383, 0.0}; +Point( 120 ) = { 0.1017350409879, 0.04710485137844, 0.0}; +Point( 121 ) = { 0.09549150281253, 0.046037443699, 0.0}; +Point( 122 ) = { 0.08942539543315, 0.04493155605656, 0.0}; +Point( 123 ) = { 0.08353937964495, 0.04378798358951, 0.0}; +Point( 124 ) = { 0.07783603724899, 0.04260755157605, 0.0}; +Point( 125 ) = { 0.07231786991975, 0.04139111187757, 0.0}; +Point( 126 ) = { 0.06698729810778, 0.04013953925954, 0.0}; +Point( 127 ) = { 0.06184665997807, 0.03885372760755, 0.0}; +Point( 128 ) = { 0.05689821038439, 0.03753458605692, 0.0}; +Point( 129 ) = { 0.05214411988029, 0.03618303505469, 0.0}; +Point( 130 ) = { 0.04758647376699, 0.0348000023736, 0.0}; +Point( 131 ) = { 0.0432272711787, 0.03338641909797, 0.0}; +Point( 132 ) = { 0.03906842420575, 0.03194321560181, 0.0}; +Point( 133 ) = { 0.03511175705587, 0.03047131753953, 0.0}; +Point( 134 ) = { 0.03135900525405, 0.0289716418698, 0.0}; +Point( 135 ) = { 0.02781181488126, 0.02744509293315, 0.0}; +Point( 136 ) = { 0.02447174185242, 0.0258925586035, 0.0}; +Point( 137 ) = { 0.02134025123397, 0.02431490653389, 0.0}; +Point( 138 ) = { 0.01841871660117, 0.02271298051574, 0.0}; +Point( 139 ) = { 0.01570841943568, 0.02108759697117, 0.0}; +Point( 140 ) = { 0.01321054856342, 0.01943954159657, 0.0}; +Point( 141 ) = { 0.0109261996331, 0.01776956617535, 0.0}; +Point( 142 ) = { 0.00885637463566, 0.01607838557678, 0.0}; +Point( 143 ) = { 0.00700198146475, 0.01436667495681, 0.0}; +Point( 144 ) = { 0.00536383351851, 0.01263506717596, 0.0}; +Point( 145 ) = { 0.00394264934276, 0.01088415044781, 0.0}; +Point( 146 ) = { 0.00273905231586, 0.009114466231, 0.0}; +Point( 147 ) = { 0.00175357037525, 0.00732650737576, 0.0}; +Point( 148 ) = { 0.00098663578586, 0.00552071653494, 0.0}; +Point( 149 ) = { 0.00043858495057, 0.0036974848482, 0.0}; +Point( 150 ) = { 0.00010965826258, 0.00185715090611, 0.0}; +Point( 151 ) = { 0.0, 0.0, 0.0, msLe }; +Point( 152 ) = { 0.00010965826258, -0.00185715090611, 0.0}; +Point( 153 ) = { 0.00043858495057, -0.0036974848482, 0.0}; +Point( 154 ) = { 0.00098663578586, -0.00552071653494, 0.0}; +Point( 155 ) = { 0.00175357037525, -0.00732650737576, 0.0}; +Point( 156 ) = { 0.00273905231586, -0.009114466231, 0.0}; +Point( 157 ) = { 0.00394264934276, -0.01088415044781, 0.0}; +Point( 158 ) = { 0.00536383351851, -0.01263506717596, 0.0}; +Point( 159 ) = { 0.00700198146475, -0.01436667495681, 0.0}; +Point( 160 ) = { 0.00885637463566, -0.01607838557678, 0.0}; +Point( 161 ) = { 0.0109261996331, -0.01776956617535, 0.0}; +Point( 162 ) = { 0.01321054856342, -0.01943954159657, 0.0}; +Point( 163 ) = { 0.01570841943568, -0.02108759697117, 0.0}; +Point( 164 ) = { 0.01841871660117, -0.02271298051574, 0.0}; +Point( 165 ) = { 0.02134025123397, -0.02431490653389, 0.0}; +Point( 166 ) = { 0.02447174185242, -0.0258925586035, 0.0}; +Point( 167 ) = { 0.02781181488126, -0.02744509293315, 0.0}; +Point( 168 ) = { 0.03135900525405, -0.0289716418698, 0.0}; +Point( 169 ) = { 0.03511175705587, -0.03047131753953, 0.0}; +Point( 170 ) = { 0.03906842420575, -0.03194321560181, 0.0}; +Point( 171 ) = { 0.0432272711787, -0.03338641909797, 0.0}; +Point( 172 ) = { 0.04758647376699, -0.0348000023736, 0.0}; +Point( 173 ) = { 0.05214411988029, -0.03618303505469, 0.0}; +Point( 174 ) = { 0.05689821038439, -0.03753458605692, 0.0}; +Point( 175 ) = { 0.06184665997807, -0.03885372760755, 0.0}; +Point( 176 ) = { 0.06698729810778, -0.04013953925954, 0.0}; +Point( 177 ) = { 0.07231786991975, -0.04139111187757, 0.0}; +Point( 178 ) = { 0.07783603724899, -0.04260755157605, 0.0}; +Point( 179 ) = { 0.08353937964495, -0.04378798358951, 0.0}; +Point( 180 ) = { 0.08942539543315, -0.04493155605656, 0.0}; +Point( 181 ) = { 0.09549150281253, -0.046037443699, 0.0}; +Point( 182 ) = { 0.1017350409879, -0.04710485137844, 0.0}; +Point( 183 ) = { 0.10815327133708, -0.04813301751383, 0.0}; +Point( 184 ) = { 0.11474337861211, -0.04912121734409, 0.0}; +Point( 185 ) = { 0.12150247217412, -0.05006876602101, 0.0}; +Point( 186 ) = { 0.1284275872613, -0.05097502151884, 0.0}; +Point( 187 ) = { 0.13551568628929, -0.05183938734803, 0.0}; +Point( 188 ) = { 0.1427636601836, -0.05266131506196, 0.0}; +Point( 189 ) = { 0.15016832974332, -0.05344030654663, 0.0}; +Point( 190 ) = { 0.15772644703566, -0.05417591608471, 0.0}; +Point( 191 ) = { 0.16543469682057, -0.05486775218683, 0.0}; +Point( 192 ) = { 0.17328969800495, -0.05551547918403, 0.0}; +Point( 193 ) = { 0.18128800512566, -0.0561188185773, 0.0}; +Point( 194 ) = { 0.18942610986084, -0.05667755014088, 0.0}; +Point( 195 ) = { 0.19770044256881, -0.05719151277812, 0.0}; +Point( 196 ) = { 0.20610737385376, -0.05766060512952, 0.0}; +Point( 197 ) = { 0.21464321615778, -0.05808478593443, 0.0}; +Point( 198 ) = { 0.22330422537833, -0.058464074149, 0.0}; +Point( 199 ) = { 0.2320866025105, -0.05879854882451, 0.0}; +Point( 200 ) = { 0.24098649531343, -0.05908834875129, 0.0}; +Point( 201 ) = { 0.25, -0.059333671875, 0.0}; +Point( 202 ) = { 0.25912316294914, -0.05953477449294, 0.0}; +Point( 203 ) = { 0.26835198244007, -0.05969197023942, 0.0}; +Point( 204 ) = { 0.27768241040754, -0.05980562887012, 0.0}; +Point( 205 ) = { 0.28711035421746, -0.05987617485653, 0.0}; +Point( 206 ) = { 0.2966316784621, -0.05990408580221, 0.0}; +Point( 207 ) = { 0.30624220677395, -0.05988989069371, 0.0}; +Point( 208 ) = { 0.31593772365766, -0.0598341679995, 0.0}; +Point( 209 ) = { 0.32571397633909, -0.05973754363096, 0.0}; +Point( 210 ) = { 0.33556667663071, -0.05960068878005, 0.0}; +Point( 211 ) = { 0.34549150281253, -0.05942431764848, 0.0}; +Point( 212 ) = { 0.35548410152776, -0.05920918508399, 0.0}; +Point( 213 ) = { 0.36554008969237, -0.05895608413888, 0.0}; +Point( 214 ) = { 0.37565505641757, -0.05866584356678, 0.0}; +Point( 215 ) = { 0.38582456494467, -0.05833932527305, 0.0}; +Point( 216 ) = { 0.39604415459112, -0.05797742173437, 0.0}; +Point( 217 ) = { 0.40630934270714, -0.05758105340305, 0.0}; +Point( 218 ) = { 0.41661562664195, -0.05715116611079, 0.0}; +Point( 219 ) = { 0.42695848571879, -0.05668872848681, 0.0}; +Point( 220 ) = { 0.43733338321785, -0.05619472940438, 0.0}; +Point( 221 ) = { 0.44773576836617, -0.05567017546926, 0.0}; +Point( 222 ) = { 0.45816107833384, -0.05511608856324, 0.0}; +Point( 223 ) = { 0.46860474023534, -0.05453350345464, 0.0}; +Point( 224 ) = { 0.4790621731354, -0.05392346548752, 0.0}; +Point( 225 ) = { 0.48952879005832, -0.05328702835989, 0.0}; +Point( 226 ) = { 0.5, -0.05262525200057, 0.0}; +Point( 227 ) = { 0.51047120994168, -0.05193920055357, 0.0}; +Point( 228 ) = { 0.5209378268646, -0.05122994047724, 0.0}; +Point( 229 ) = { 0.53139525976466, -0.05049853876514, 0.0}; +Point( 230 ) = { 0.54183892166616, -0.0497460612939, 0.0}; +Point( 231 ) = { 0.55226423163383, -0.04897357130255, 0.0}; +Point( 232 ) = { 0.56266661678215, -0.04818212800662, 0.0}; +Point( 233 ) = { 0.57304151428121, -0.04737278534922, 0.0}; +Point( 234 ) = { 0.58338437335805, -0.04654659089014, 0.0}; +Point( 235 ) = { 0.59369065729286, -0.04570458483296, 0.0}; +Point( 236 ) = { 0.60395584540888, -0.04484779918912, 0.0}; +Point( 237 ) = { 0.61417543505533, -0.04397725707679, 0.0}; +Point( 238 ) = { 0.62434494358243, -0.04309397215141, 0.0}; +Point( 239 ) = { 0.63445991030763, -0.04219894816377, 0.0}; +Point( 240 ) = { 0.64451589847224, -0.04129317864062, 0.0}; +Point( 241 ) = { 0.65450849718747, -0.0403776466819, 0.0}; +Point( 242 ) = { 0.66443332336929, -0.03945332486788, 0.0}; +Point( 243 ) = { 0.67428602366091, -0.03852117526877, 0.0}; +Point( 244 ) = { 0.68406227634234, -0.03758214954874, 0.0}; +Point( 245 ) = { 0.69375779322605, -0.03663718915547, 0.0}; +Point( 246 ) = { 0.7033683215379, -0.03568722558628, 0.0}; +Point( 247 ) = { 0.71288964578254, -0.03473318072085, 0.0}; +Point( 248 ) = { 0.72231758959246, -0.03377596721082, 0.0}; +Point( 249 ) = { 0.73164801755993, -0.03281648891572, 0.0}; +Point( 250 ) = { 0.74087683705086, -0.03185564137496, 0.0}; +Point( 251 ) = { 0.75, -0.03089431230516, 0.0}; +Point( 252 ) = { 0.75901350468657, -0.02993338211239, 0.0}; +Point( 253 ) = { 0.7679133974895, -0.02897372440866, 0.0}; +Point( 254 ) = { 0.77669577462167, -0.02801620652246, 0.0}; +Point( 255 ) = { 0.78535678384222, -0.02706168999315, 0.0}; +Point( 256 ) = { 0.79389262614624, -0.02611103103947, 0.0}; +Point( 257 ) = { 0.80229955743119, -0.02516508099279, 0.0}; +Point( 258 ) = { 0.81057389013916, -0.02422468668617, 0.0}; +Point( 259 ) = { 0.81871199487434, -0.02329069079083, 0.0}; +Point( 260 ) = { 0.82671030199505, -0.02236393209232, 0.0}; +Point( 261 ) = { 0.83456530317943, -0.02144524569925, 0.0}; +Point( 262 ) = { 0.84227355296434, -0.02053546317813, 0.0}; +Point( 263 ) = { 0.84983167025668, -0.01963541260873, 0.0}; +Point( 264 ) = { 0.8572363398164, -0.01874591855516, 0.0}; +Point( 265 ) = { 0.86448431371071, -0.01786780194847, 0.0}; +Point( 266 ) = { 0.8715724127387, -0.01700187987791, 0.0}; +Point( 267 ) = { 0.87849752782588, -0.01614896528828, 0.0}; +Point( 268 ) = { 0.88525662138789, -0.01530986658219, 0.0}; +Point( 269 ) = { 0.89184672866292, -0.01448538712671, 0.0}; +Point( 270 ) = { 0.8982649590121, -0.01367632466478, 0.0}; +Point( 271 ) = { 0.90450849718747, -0.01288347063272, 0.0}; +Point( 272 ) = { 0.91057460456685, -0.01210760938604, 0.0}; +Point( 273 ) = { 0.91646062035505, -0.01134951733663, 0.0}; +Point( 274 ) = { 0.92216396275101, -0.01060996200508, 0.0}; +Point( 275 ) = { 0.92768213008025, -0.00988970099293, 0.0}; +Point( 276 ) = { 0.93301270189222, -0.00918948088016, 0.0}; +Point( 277 ) = { 0.93815334002193, -0.00851003605407, 0.0}; +Point( 278 ) = { 0.94310178961561, -0.00785208747637, 0.0}; +Point( 279 ) = { 0.94785588011971, -0.00721634139577, 0.0}; +Point( 280 ) = { 0.95241352623301, -0.00660348801398, 0.0}; +Point( 281 ) = { 0.9567727288213, -0.00601420011357, 0.0}; +Point( 282 ) = { 0.96093157579425, -0.00544913165641, 0.0}; +Point( 283 ) = { 0.96488824294413, -0.00490891636171, 0.0}; +Point( 284 ) = { 0.96864099474595, -0.00439416627328, 0.0}; +Point( 285 ) = { 0.97218818511874, -0.0039054703252, 0.0}; +Point( 286 ) = { 0.97552825814758, -0.00344339291591, 0.0}; +Point( 287 ) = { 0.97865974876603, -0.00300847250009, 0.0}; +Point( 288 ) = { 0.98158128339883, -0.00260122020822, 0.0}; +Point( 289 ) = { 0.98429158056432, -0.0022221185031, 0.0}; +Point( 290 ) = { 0.98678945143658, -0.00187161988278, 0.0}; +Point( 291 ) = { 0.9890738003669, -0.0015501456389, 0.0}; +Point( 292 ) = { 0.99114362536434, -0.00125808467902, 0.0}; +Point( 293 ) = { 0.99299801853525, -0.00099579242133, 0.0}; +Point( 294 ) = { 0.99463616648149, -0.00076358976946, 0.0}; +Point( 295 ) = { 0.99605735065724, -0.00056176217462, 0.0}; +Point( 296 ) = { 0.99726094768414, -0.00039055879171, 0.0}; +Point( 297 ) = { 0.99824642962475, -0.0002501917354, 0.0}; +Point( 298 ) = { 0.99901336421414, -0.00014083544147, 0.0}; +Point( 299 ) = { 0.99956141504943, -6.262613794e-05, 0.0}; +Point( 300 ) = { 0.99989034173742, -1.566142976e-05, 0.0}; +// Point( 301 ) = { 1.0, 0.0, 0.0, msTe }; + +Spline(1) = {Le:1}; // upper side +Spline(2) = {1, 300:Le}; // lower side + +// Rotation +If (angle != 0) + For i In {Te:N:1} + Rotate{{0, 0, 1}, {xRot, 0, 0}, -angle} {Point{i};} + EndFor +EndIf + +// Farfield +Point(10001) = {1+xLgt, 0, 0,msF}; +Point(10002) = {1+xLgt, yLgt, 0,msF}; +Point(10003) = {-xLgt, yLgt, 0,msF}; +Point(10004) = {-xLgt, 0, 0,msF}; +Point(10005) = {-xLgt,-yLgt, 0,msF}; +Point(10006) = {1+xLgt, -yLgt, 0,msF}; + +Line(10001) = {10001, 10002}; +Line(10002) = {10002, 10003}; +Line(10003) = {10003, 10004}; +Line(10004) = {10004, 10005}; +Line(10005) = {10005, 10006}; +Line(10006) = {10006, 10001}; + +// Front and wake +Line(10007) = {Le, 10004}; +Line(10008) = {Te, 10001}; + +// Internal field +Line Loop(20001) = {10008, 10001, 10002, 10003, -10007, 1}; +Line Loop(20002) = {10007, 10004, 10005, 10006, -10008, 2}; +Plane Surface(30001) = {20001}; +Plane Surface(30002) = {20002}; + +/************************* + Mesh Options + *************************/ + +Mesh.Algorithm = 5; // Delaunay + +/************************* + Physical Groups + *************************/ + +Physical Line("farfield") = {10003, 10004, 10002, 10005, 10001, 10006}; +Physical Line("airfoil") = {1}; +Physical Line("airfoil_") = {2}; +Physical Surface("field") = {30001, 30002}; diff --git a/blast/models/su2/n0012_su2.su2 b/blast/models/su2/n0012_su2.su2 new file mode 100644 index 0000000000000000000000000000000000000000..b5e9cafa987115bead149400e5201906143f22fb --- /dev/null +++ b/blast/models/su2/n0012_su2.su2 @@ -0,0 +1,3466 @@ +NDIME= 2 +NELEM= 2074 +5 337 438 519 0 +5 250 251 393 1 +5 438 337 518 2 +5 233 232 366 3 +5 437 308 574 4 +5 309 378 432 5 +5 367 268 628 6 +5 17 18 429 7 +5 475 326 558 8 +5 432 378 523 9 +5 427 321 593 10 +5 366 287 579 11 +5 407 285 420 12 +5 302 341 445 13 +5 331 419 630 14 +5 309 322 378 15 +5 318 319 370 16 +5 92 93 410 17 +5 372 286 671 18 +5 100 101 412 19 +5 102 103 411 20 +5 316 268 524 21 +5 498 283 617 22 +5 421 278 479 23 +5 519 392 605 24 +5 250 393 405 25 +5 320 426 660 26 +5 418 470 561 27 +5 334 352 597 28 +5 327 297 605 29 +5 268 367 488 30 +5 373 280 416 31 +5 245 246 440 32 +5 366 232 404 33 +5 349 309 432 34 +5 79 80 433 35 +5 424 301 462 36 +5 319 311 369 37 +5 332 647 692 38 +5 288 311 319 39 +5 280 373 651 40 +5 395 508 636 41 +5 337 353 518 42 +5 460 256 591 43 +5 388 340 477 44 +5 389 372 671 45 +5 294 318 329 46 +5 315 340 388 47 +5 257 258 389 48 +5 374 318 452 49 +5 265 331 409 50 +5 344 395 653 51 +5 387 602 694 52 +5 379 274 417 53 +5 353 337 582 54 +5 48 49 447 55 +5 286 427 593 56 +5 420 292 428 57 +5 85 86 438 58 +5 353 303 354 59 +5 419 331 704 60 +5 242 442 595 61 +5 280 431 495 62 +5 359 213 669 63 +5 58 59 432 64 +5 256 257 591 65 +5 310 598 677 66 +5 339 315 388 67 +5 339 388 476 68 +5 344 261 395 69 +5 289 498 590 70 +5 417 274 521 71 +5 439 303 493 72 +5 416 280 495 73 +5 312 428 648 74 +5 265 403 653 75 +5 257 389 591 76 +5 44 45 441 77 +5 281 393 606 78 +5 447 364 532 79 +5 246 247 414 80 +5 31 32 470 81 +5 274 379 617 82 +5 306 436 563 83 +5 431 216 495 84 +5 328 329 418 85 +5 243 242 595 86 +5 260 402 558 87 +5 387 215 602 88 +5 328 294 329 89 +5 446 386 556 90 +5 352 334 443 91 +5 352 300 597 92 +5 491 366 579 93 +5 249 250 405 94 +5 343 296 606 95 +5 318 370 452 96 +5 38 39 446 97 +5 263 444 611 98 +5 214 215 387 99 +5 337 519 605 100 +5 451 322 548 101 +5 334 295 564 102 +5 278 421 554 103 +5 427 286 573 104 +5 369 311 375 105 +5 240 239 434 106 +5 297 327 424 107 +5 443 334 522 108 +5 293 341 474 109 +5 492 398 564 110 +5 27 28 452 111 +5 5 244 520 112 +5 305 346 358 113 +5 313 386 446 114 +5 282 437 574 115 +5 394 367 628 116 +5 421 321 688 117 +5 342 305 358 118 +5 285 407 502 119 +5 321 427 644 120 +5 395 265 653 121 +5 275 391 464 122 +5 417 521 640 123 +5 647 356 692 124 +5 440 339 461 125 +5 411 505 514 126 +5 341 293 487 127 +5 611 320 660 128 +5 377 212 589 129 +5 376 363 695 130 +5 329 318 374 131 +5 379 498 617 132 +5 308 437 577 133 +5 97 98 443 134 +5 321 422 688 135 +5 253 254 425 136 +5 245 440 461 137 +5 353 354 455 138 +5 213 359 589 139 +5 351 327 435 140 +5 316 339 440 141 +5 480 407 576 142 +5 313 328 386 143 +5 272 407 420 144 +5 216 217 495 145 +5 402 475 558 146 +5 296 343 463 147 +5 249 405 467 148 +5 492 335 528 149 +5 303 353 582 150 +5 269 464 601 151 +5 268 316 448 152 +5 284 420 428 153 +5 436 306 513 154 +5 336 540 614 155 +5 373 416 520 156 +5 266 482 491 157 +5 427 260 644 158 +5 374 452 569 159 +5 346 306 381 160 +5 413 276 450 161 +5 448 317 628 162 +5 464 391 601 163 +5 272 417 640 164 +5 332 304 647 165 +5 246 414 440 166 +5 363 376 456 167 +5 335 492 564 168 +5 306 345 381 169 +5 335 536 618 170 +5 362 313 446 171 +5 10 11 456 172 +5 338 317 448 173 +5 297 337 605 174 +5 287 366 404 175 +5 470 374 560 176 +5 286 372 608 177 +5 55 56 451 178 +5 345 307 382 179 +5 496 279 620 180 +5 12 13 473 181 +5 505 340 514 182 +5 423 611 660 183 +5 0 245 461 184 +5 307 347 382 185 +5 232 231 404 186 +5 76 77 449 187 +5 380 557 690 188 +5 237 236 445 189 +5 347 308 385 190 +5 74 75 454 191 +5 308 349 385 192 +5 378 322 451 193 +5 72 73 453 194 +5 213 214 669 195 +5 82 83 455 196 +5 304 332 439 197 +5 322 401 548 198 +5 531 351 637 199 +5 434 239 487 200 +5 253 425 463 201 +5 334 398 522 202 +5 300 352 614 203 +5 275 424 462 204 +5 356 342 449 205 +5 391 275 462 206 +5 410 93 528 207 +5 416 495 679 208 +5 70 71 466 209 +5 376 399 512 210 +5 293 474 609 211 +5 68 69 465 212 +5 342 358 454 213 +5 384 278 607 214 +5 66 67 469 215 +5 291 496 579 216 +5 64 65 468 217 +5 365 274 525 218 +5 498 379 590 219 +5 400 269 601 220 +5 62 63 472 221 +5 60 61 471 222 +5 14 15 483 223 +5 580 365 684 224 +5 479 384 657 225 +5 92 410 504 226 +5 346 381 466 227 +5 35 36 481 228 +5 314 431 526 229 +5 429 18 584 230 +5 377 494 635 231 +5 100 412 507 232 +5 412 101 506 233 +5 102 411 506 234 +5 411 103 505 235 +5 267 407 480 236 +5 576 272 640 237 +5 317 338 467 238 +5 458 271 559 239 +5 358 346 453 240 +5 409 331 576 241 +5 488 367 668 242 +5 292 420 634 243 +5 430 281 606 244 +5 381 345 465 245 +5 274 365 521 246 +5 481 328 571 247 +5 305 486 513 248 +5 431 280 526 249 +5 296 380 606 250 +5 488 315 524 251 +5 345 382 469 252 +5 323 497 666 253 +5 318 294 459 254 +5 295 334 597 255 +5 382 347 468 256 +5 393 343 606 257 +5 322 309 515 258 +5 341 302 474 259 +5 42 43 485 260 +5 420 284 599 261 +5 347 385 472 262 +5 311 357 375 263 +5 350 442 624 264 +5 212 377 635 265 +5 40 41 484 266 +5 278 348 693 267 +5 385 349 471 268 +5 259 2 572 269 +5 219 5 520 270 +5 105 106 477 271 +5 348 278 554 272 +5 288 319 662 273 +5 404 231 643 274 +5 271 365 580 275 +5 107 108 476 276 +5 248 467 631 277 +5 405 317 467 278 +5 493 297 626 279 +5 444 320 611 280 +5 418 329 470 281 +5 444 263 557 282 +5 379 417 599 283 +5 367 394 655 284 +5 17 429 535 285 +5 273 391 705 286 +5 649 397 659 287 +5 361 310 677 288 +5 276 439 493 289 +5 261 344 645 290 +5 421 479 616 291 +5 218 416 679 292 +5 260 427 527 293 +5 433 80 517 294 +5 255 256 657 295 +5 242 241 624 296 +5 628 317 646 297 +5 291 361 677 298 +5 79 433 516 299 +5 355 464 701 300 +5 504 410 618 301 +5 21 22 503 302 +5 428 298 590 303 +5 262 390 604 304 +5 326 415 636 305 +5 25 26 501 306 +5 19 20 500 307 +5 23 24 499 308 +5 252 253 463 309 +5 324 364 447 310 +5 494 372 572 311 +5 407 267 502 312 +5 218 219 416 313 +5 248 249 467 314 +5 344 557 645 315 +5 482 333 491 316 +5 270 521 656 317 +5 508 326 636 318 +5 424 327 629 319 +5 351 435 637 320 +5 507 412 614 321 +5 428 312 682 322 +5 212 213 589 323 +5 236 235 478 324 +5 340 505 529 325 +5 351 504 618 326 +5 2 210 572 327 +5 425 296 463 328 +5 428 292 648 329 +5 526 383 663 330 +5 379 284 590 331 +5 268 488 524 332 +5 442 350 700 333 +5 438 86 519 334 +5 490 489 491 335 +5 340 315 603 336 +5 85 438 518 337 +5 604 293 609 338 +5 8 512 578 339 +5 598 279 677 340 +5 271 458 656 341 +5 393 251 627 342 +5 315 339 524 343 +5 389 258 667 344 +5 521 270 640 345 +5 462 301 536 346 +5 337 297 582 347 +5 445 236 478 348 +5 352 507 614 349 +5 602 314 694 350 +5 354 303 639 351 +5 429 371 535 352 +5 94 95 492 353 +5 359 427 573 354 +5 494 211 635 355 +5 540 300 614 356 +5 395 261 508 357 +5 444 344 652 358 +5 278 384 479 359 +5 496 291 677 360 +5 402 260 642 361 +5 397 276 493 362 +5 8 9 512 363 +5 281 430 632 364 +5 292 313 648 365 +5 431 314 602 366 +5 415 419 704 367 +5 300 509 510 368 +5 536 301 618 369 +5 432 59 551 370 +5 247 248 631 371 +5 500 357 584 372 +5 239 238 487 373 +5 447 49 533 374 +5 336 514 540 375 +5 58 432 523 376 +5 244 243 619 377 +5 48 447 532 378 +5 442 242 624 379 +5 312 362 368 380 +5 328 418 571 381 +5 335 410 528 382 +5 293 434 487 383 +5 408 323 665 384 +5 331 265 704 385 +5 413 450 580 386 +5 258 259 667 387 +5 210 211 494 388 +5 256 460 657 389 +5 360 312 368 390 +5 496 620 622 391 +5 339 316 524 392 +5 514 290 540 393 +5 315 488 603 394 +5 464 269 701 395 +5 437 282 525 396 +5 252 463 627 397 +5 386 328 481 398 +5 361 291 363 399 +5 99 100 507 400 +5 103 104 505 401 +5 101 102 506 402 +5 91 92 504 403 +5 344 444 557 404 +5 235 234 490 405 +5 234 233 489 406 +5 298 428 682 407 +5 458 270 656 408 +5 441 546 592 409 +5 459 294 634 410 +5 319 318 662 411 +5 327 351 629 412 +5 241 240 623 413 +5 251 252 627 414 +5 498 497 515 415 +5 327 392 435 416 +5 480 264 621 417 +5 44 441 567 418 +5 380 348 557 419 +5 233 366 489 420 +5 439 332 639 421 +5 290 488 668 422 +5 80 81 517 423 +5 311 288 613 424 +5 78 79 516 425 +5 441 45 546 426 +5 313 292 552 427 +5 301 424 629 428 +5 477 340 529 429 +5 290 514 603 430 +5 295 536 564 431 +5 86 87 519 432 +5 658 299 673 433 +5 214 387 669 434 +5 254 255 680 435 +5 426 458 559 436 +5 84 85 518 437 +5 16 17 535 438 +5 328 313 552 439 +5 305 342 596 440 +5 443 98 530 441 +5 97 443 522 442 +5 449 342 539 443 +5 536 335 564 444 +5 342 454 539 445 +5 277 413 580 446 +5 216 431 602 447 +5 654 273 668 448 +5 360 368 485 449 +5 9 10 511 450 +5 393 281 687 451 +5 399 404 643 452 +5 373 520 619 453 +5 276 413 676 454 +5 363 291 695 455 +5 215 216 602 456 +5 296 607 693 457 +5 259 572 667 458 +5 57 58 523 459 +5 470 32 561 460 +5 295 462 536 461 +5 391 273 601 462 +5 346 305 689 463 +5 96 97 522 464 +5 493 303 582 465 +5 520 244 619 466 +5 486 305 596 467 +5 475 262 678 468 +5 231 230 643 469 +5 267 480 621 470 +5 450 276 649 471 +5 446 39 570 472 +5 49 50 533 473 +5 31 470 560 474 +5 413 277 486 475 +5 326 475 678 476 +5 380 430 606 477 +5 306 346 689 478 +5 47 48 532 479 +5 422 321 644 480 +5 238 237 664 481 +5 435 392 615 482 +5 462 295 705 483 +5 372 494 608 484 +5 275 464 659 485 +5 368 362 484 486 +5 486 304 676 487 +5 331 480 576 488 +5 419 604 609 489 +5 425 254 680 490 +5 294 328 552 491 +5 514 340 603 492 +5 450 355 559 493 +5 240 434 623 494 +5 38 446 556 495 +5 504 351 531 496 +5 351 618 629 497 +5 376 287 399 498 +5 509 300 540 499 +5 478 235 490 500 +5 375 357 500 501 +5 305 513 689 502 +5 372 389 667 503 +5 339 476 594 504 +5 460 479 657 505 +5 329 374 470 506 +5 508 261 688 507 +5 45 46 546 508 +5 557 348 645 509 +5 310 361 371 510 +5 345 306 563 511 +5 336 412 506 512 +5 411 336 506 513 +5 546 364 592 514 +5 346 466 543 515 +5 414 316 440 516 +5 265 395 636 517 +5 307 345 563 518 +5 416 219 520 519 +5 75 76 539 520 +5 489 366 491 521 +5 453 346 543 522 +5 73 74 538 523 +5 211 3 635 524 +5 32 33 561 525 +5 261 554 688 526 +5 314 526 663 527 +5 93 94 528 528 +5 579 287 695 529 +5 342 356 647 530 +5 37 38 556 531 +5 394 628 646 532 +5 512 399 578 533 +5 30 31 560 534 +5 266 491 579 535 +5 71 72 543 536 +5 467 338 631 537 +5 465 345 544 538 +5 98 99 530 539 +5 104 105 529 540 +5 273 509 668 541 +5 487 238 664 542 +5 69 70 542 543 +5 347 307 574 544 +5 427 359 527 545 +5 90 91 531 546 +5 27 452 587 547 +5 345 469 544 548 +5 626 275 659 549 +5 436 277 684 550 +5 67 68 544 551 +5 54 55 548 552 +5 308 347 574 553 +5 65 66 547 554 +5 0 461 594 555 +5 63 64 549 556 +5 300 510 597 557 +5 61 62 550 558 +5 320 444 652 559 +5 59 60 551 560 +5 272 420 599 561 +5 357 429 584 562 +5 468 347 549 563 +5 452 28 569 564 +5 448 316 691 565 +5 424 275 626 566 +5 347 472 549 567 +5 349 308 577 568 +5 572 372 667 569 +5 282 574 686 570 +5 449 77 545 571 +5 700 350 703 572 +5 309 349 577 573 +5 28 29 569 574 +5 510 273 705 575 +5 471 349 551 576 +5 76 449 539 577 +5 83 84 537 578 +5 563 436 686 579 +5 464 355 659 580 +5 397 493 626 581 +5 455 83 537 582 +5 81 82 541 583 +5 230 1 578 584 +5 361 363 473 585 +5 11 12 553 586 +5 414 631 691 587 +5 454 75 539 588 +5 82 455 541 589 +5 77 78 545 590 +5 451 56 555 591 +5 74 454 538 592 +5 3 212 635 593 +5 507 352 530 594 +5 439 276 676 595 +5 453 73 538 596 +5 513 306 689 597 +5 277 436 513 598 +5 72 453 543 599 +5 412 336 614 600 +5 333 302 478 601 +5 55 451 548 602 +5 304 486 596 603 +5 436 282 686 604 +5 390 262 633 605 +5 284 379 599 606 +5 297 493 582 607 +5 234 489 490 608 +5 557 263 690 609 +5 303 439 639 610 +5 330 593 616 611 +5 43 44 567 612 +5 293 604 703 613 +5 407 272 576 614 +5 230 578 643 615 +5 355 450 649 616 +5 607 278 693 617 +5 41 42 566 618 +5 410 335 618 619 +5 282 436 610 620 +5 56 57 555 621 +5 466 71 543 622 +5 108 0 594 623 +5 269 400 658 624 +5 34 35 571 625 +5 39 40 570 626 +5 70 466 542 627 +5 13 14 565 628 +5 465 69 542 629 +5 105 477 529 630 +5 68 465 544 631 +5 414 247 631 632 +5 4 218 679 633 +5 371 361 483 634 +5 469 67 544 635 +5 66 469 547 636 +5 477 106 625 637 +5 365 271 656 638 +5 488 290 603 639 +5 468 65 547 640 +5 518 353 537 641 +5 64 468 549 642 +5 472 63 549 643 +5 355 649 659 644 +5 62 472 550 645 +5 463 343 627 646 +5 399 287 404 647 +5 348 554 645 648 +5 471 61 550 649 +5 497 289 666 650 +5 475 383 633 651 +5 60 471 551 652 +5 474 302 661 653 +5 391 462 705 654 +5 107 476 625 655 +5 365 525 610 656 +5 262 475 633 657 +5 426 320 458 658 +5 423 658 673 659 +5 336 411 514 660 +5 578 399 643 661 +5 10 456 511 662 +5 400 299 658 663 +5 423 263 611 664 +5 46 47 568 665 +5 390 700 703 666 +5 384 425 680 667 +5 299 632 673 668 +5 415 262 419 669 +5 88 89 615 670 +5 420 285 634 671 +5 237 445 664 672 +5 106 107 625 673 +5 290 509 540 674 +5 370 319 406 675 +5 26 27 587 676 +5 283 498 515 677 +5 18 19 584 678 +5 24 25 585 679 +5 319 369 406 680 +5 20 21 588 681 +5 22 23 586 682 +5 652 344 653 683 +5 1 8 578 684 +5 430 380 690 685 +5 476 108 594 686 +5 456 11 553 687 +5 497 322 515 688 +5 370 406 501 689 +5 434 350 623 690 +5 437 283 698 691 +5 415 326 678 692 +5 302 445 478 693 +5 36 37 575 694 +5 497 323 699 695 +5 573 286 608 696 +5 367 654 668 697 +5 406 369 499 698 +5 457 401 699 699 +5 318 459 662 700 +5 322 497 699 701 +5 574 307 686 702 +5 397 626 659 703 +5 94 492 528 704 +5 15 16 581 705 +5 473 13 565 706 +5 276 397 649 707 +5 348 380 693 708 +5 483 361 565 709 +5 12 473 553 710 +5 369 375 503 711 +5 210 494 572 712 +5 604 390 703 713 +5 494 377 608 714 +5 89 90 637 715 +5 577 437 698 716 +5 29 30 583 717 +5 510 295 597 718 +5 330 591 671 719 +5 265 409 641 720 +5 360 485 567 721 +5 403 265 641 722 +5 296 425 607 723 +5 481 36 575 724 +5 405 393 687 725 +5 325 442 700 726 +5 492 95 685 727 +5 9 511 512 728 +5 398 334 564 729 +5 496 266 579 730 +5 87 88 650 731 +5 35 481 571 732 +5 422 260 558 733 +5 99 507 530 734 +5 361 473 565 735 +5 302 333 482 736 +5 505 104 529 737 +5 91 504 531 738 +5 460 330 479 739 +5 485 43 567 740 +5 217 4 679 741 +5 525 282 610 742 +5 349 432 551 743 +5 42 485 566 744 +5 482 266 622 745 +5 479 330 616 746 +5 425 384 607 747 +5 268 448 628 748 +5 330 460 591 749 +5 484 41 566 750 +5 297 424 626 751 +5 486 277 513 752 +5 483 15 581 753 +5 593 321 616 754 +5 40 484 570 755 +5 590 298 600 756 +5 383 526 612 757 +5 271 450 559 758 +5 14 483 565 759 +5 430 263 673 760 +5 299 394 632 761 +5 523 378 555 762 +5 264 480 630 763 +5 53 54 675 764 +5 343 393 627 765 +5 610 436 684 766 +5 511 376 512 767 +5 521 365 656 768 +5 289 497 498 769 +5 51 52 670 770 +5 474 264 609 771 +5 52 53 672 772 +5 288 459 502 773 +5 552 292 634 774 +5 95 96 685 775 +5 84 518 537 776 +5 291 579 695 777 +5 517 81 541 778 +5 516 356 545 779 +5 392 327 605 780 +5 270 458 534 781 +5 401 457 672 782 +5 78 516 545 783 +5 484 362 570 784 +5 519 87 650 785 +5 509 290 668 786 +5 600 324 666 787 +5 457 408 670 788 +5 323 408 457 789 +5 364 324 681 790 +5 409 576 640 791 +5 50 51 696 792 +5 33 34 697 793 +5 283 437 617 794 +5 654 367 655 795 +5 480 331 630 796 +5 615 392 650 797 +5 96 522 685 798 +5 284 428 590 799 +5 665 323 666 800 +5 508 422 558 801 +5 445 341 664 802 +5 260 527 642 803 +5 422 508 688 804 +5 317 405 687 805 +5 263 423 673 806 +5 618 301 629 807 +5 241 623 624 808 +5 663 402 694 809 +5 461 339 594 810 +5 359 573 589 811 +5 501 26 587 812 +5 509 273 510 813 +5 25 501 585 814 +5 380 296 693 815 +5 503 22 586 816 +5 554 261 645 817 +5 499 24 585 818 +5 255 657 680 819 +5 350 434 703 820 +5 21 503 588 821 +5 23 499 586 822 +5 383 475 663 823 +5 19 500 584 824 +5 500 20 588 825 +5 354 517 541 826 +5 285 459 634 827 +5 352 443 530 828 +5 333 490 491 829 +5 57 523 555 830 +5 289 590 600 831 +5 90 531 637 832 +5 288 562 613 833 +5 441 360 567 834 +5 299 400 655 835 +5 312 360 682 836 +5 364 546 568 837 +5 482 396 661 838 +5 458 320 534 839 +5 417 272 599 840 +5 419 262 604 841 +5 532 364 568 842 +5 559 355 701 843 +5 371 429 638 844 +5 362 312 648 845 +5 437 525 617 846 +5 260 422 644 847 +5 279 598 613 848 +5 394 299 655 849 +5 459 285 502 850 +5 353 455 537 851 +5 554 421 688 852 +5 333 478 490 853 +5 294 552 634 854 +5 266 496 622 855 +5 295 510 705 856 +5 377 573 608 857 +5 341 487 664 858 +5 533 50 696 859 +5 47 532 568 860 +5 288 502 562 861 +5 325 612 651 862 +5 615 89 637 863 +5 304 439 676 864 +5 370 501 587 865 +5 264 396 621 866 +5 88 615 650 867 +5 413 486 676 868 +5 287 376 695 869 +5 316 414 691 870 +5 401 672 675 871 +5 546 46 568 872 +5 450 271 580 873 +5 243 595 619 874 +5 313 362 648 875 +5 321 421 616 876 +5 591 389 671 877 +5 632 430 673 878 +5 499 369 586 879 +5 338 448 691 880 +5 623 350 624 881 +5 54 548 675 882 +5 495 217 679 883 +5 357 311 598 884 +5 369 503 586 885 +5 640 270 641 886 +5 264 474 661 887 +5 362 446 570 888 +5 573 377 589 889 +5 556 386 575 890 +5 326 508 558 891 +5 612 325 674 892 +5 360 592 682 893 +5 263 430 690 894 +5 515 309 698 895 +5 323 457 699 896 +5 16 535 581 897 +5 279 562 620 898 +5 279 496 677 899 +5 592 364 681 900 +5 37 556 575 901 +5 277 580 684 902 +5 632 394 646 903 +5 527 359 669 904 +5 631 338 691 905 +5 596 342 647 906 +5 270 534 641 907 +5 598 311 613 908 +5 561 33 697 909 +5 526 280 612 910 +5 593 330 671 911 +5 390 633 674 912 +5 30 560 583 913 +5 670 408 696 914 +5 324 600 681 915 +5 357 598 638 916 +5 569 29 583 917 +5 374 569 583 918 +5 390 674 700 919 +5 392 519 650 920 +5 281 632 646 921 +5 286 593 671 922 +5 560 374 583 923 +5 289 600 666 924 +5 595 442 702 925 +5 522 398 685 926 +5 356 449 545 927 +5 657 384 680 928 +5 34 571 697 929 +5 646 317 687 930 +5 534 320 652 931 +5 356 516 692 932 +5 672 53 675 933 +5 442 325 702 934 +5 670 52 672 935 +5 378 451 555 936 +5 396 264 661 937 +5 360 441 592 938 +5 302 482 661 939 +5 455 354 541 940 +5 265 636 704 941 +5 314 663 694 942 +5 502 267 562 943 +5 388 477 625 944 +5 601 273 654 945 +5 452 370 587 946 +5 595 373 619 947 +5 51 670 696 948 +5 517 354 683 949 +5 354 639 683 950 +5 476 388 625 951 +5 562 279 613 952 +5 527 387 642 953 +5 307 563 686 954 +5 609 264 630 955 +5 383 612 674 956 +5 475 402 663 957 +5 454 358 538 958 +5 400 654 655 959 +5 358 453 538 960 +5 310 371 638 961 +5 398 492 685 962 +5 269 658 660 963 +5 373 595 702 964 +5 269 660 701 965 +5 434 293 703 966 +5 401 322 699 967 +5 642 387 694 968 +5 262 415 678 969 +5 651 373 702 970 +5 309 577 698 971 +5 466 381 542 972 +5 381 465 542 973 +5 620 396 622 974 +5 535 371 581 975 +5 592 298 682 976 +5 548 401 675 977 +5 469 382 547 978 +5 382 468 547 979 +5 525 274 617 980 +5 472 385 550 981 +5 385 471 550 982 +5 325 651 702 983 +5 332 433 683 984 +5 433 332 692 985 +5 459 288 662 986 +5 674 325 700 987 +5 298 592 681 988 +5 598 310 638 989 +5 639 332 683 990 +5 387 527 669 991 +5 409 640 641 992 +5 386 481 575 993 +5 403 652 653 994 +5 456 376 511 995 +5 433 517 683 996 +5 402 642 694 997 +5 620 267 621 998 +5 396 620 621 999 +5 516 433 692 1000 +5 612 280 651 1001 +5 408 533 696 1002 +5 435 615 637 1003 +5 396 482 622 1004 +5 429 357 638 1005 +5 283 515 698 1006 +5 660 426 701 1007 +5 426 559 701 1008 +5 633 383 674 1009 +5 571 418 697 1010 +5 600 298 681 1011 +5 485 368 566 1012 +5 368 484 566 1013 +5 533 408 665 1014 +5 363 456 553 1015 +5 371 483 581 1016 +5 304 596 647 1017 +5 534 403 641 1018 +5 447 533 665 1019 +5 473 363 553 1020 +5 403 534 652 1021 +5 324 665 666 1022 +5 418 561 697 1023 +5 324 447 665 1024 +5 562 267 620 1025 +5 365 610 684 1026 +5 400 601 654 1027 +5 658 423 660 1028 +5 419 609 630 1029 +5 501 406 585 1030 +5 406 499 585 1031 +5 636 415 704 1032 +5 281 646 687 1033 +5 503 375 588 1034 +5 375 500 588 1035 +5 457 670 672 1036 +5 884 783 965 1037 +5 251 250 839 1038 +5 783 884 964 1039 +5 232 233 812 1040 +5 754 883 1020 1041 +5 824 755 878 1042 +5 714 813 1074 1043 +5 199 200 875 1044 +5 772 921 1004 1045 +5 824 878 969 1046 +5 767 873 1039 1047 +5 733 812 1025 1048 +5 731 853 866 1049 +5 787 748 891 1050 +5 865 777 1076 1051 +5 768 755 824 1052 +5 765 764 816 1053 +5 124 125 856 1054 +5 732 818 1117 1055 +5 116 117 858 1056 +5 114 115 857 1057 +5 714 762 970 1058 +5 729 944 1063 1059 +5 724 867 925 1060 +5 838 965 1051 1061 +5 839 250 851 1062 +5 872 766 1106 1063 +5 916 864 1007 1064 +5 798 780 1043 1065 +5 743 773 1051 1066 +5 813 714 934 1067 +5 726 819 862 1068 +5 246 245 886 1069 +5 232 812 850 1070 +5 755 795 878 1071 +5 137 138 879 1072 +5 747 870 908 1073 +5 757 765 815 1074 +5 1093 778 1138 1075 +5 757 734 765 1076 +5 819 726 1097 1077 +5 954 841 1082 1078 +5 799 783 964 1079 +5 256 906 1037 1080 +5 786 834 923 1081 +5 818 835 1117 1082 +5 764 740 775 1083 +5 786 761 834 1084 +5 258 257 835 1085 +5 764 820 898 1086 +5 777 711 855 1087 +5 841 790 1099 1088 +5 1048 833 1140 1089 +5 720 825 863 1090 +5 783 799 1028 1091 +5 168 169 893 1092 +5 873 732 1039 1093 +5 738 866 874 1094 +5 131 132 884 1095 +5 749 799 800 1096 +5 777 865 1150 1097 +5 888 242 1041 1098 +5 877 726 941 1099 +5 226 805 1115 1100 +5 158 159 878 1101 +5 257 256 1037 1102 +5 1044 756 1123 1103 +5 761 785 834 1104 +5 834 785 922 1105 +5 707 790 841 1106 +5 944 735 1036 1107 +5 720 863 967 1108 +5 749 885 939 1109 +5 726 862 941 1110 +5 874 758 1094 1111 +5 849 711 1099 1112 +5 835 257 1037 1113 +5 172 173 887 1114 +5 839 727 1052 1115 +5 810 893 978 1116 +5 247 246 860 1117 +5 185 186 916 1118 +5 825 720 1063 1119 +5 882 752 1009 1120 +5 223 877 941 1121 +5 775 774 864 1122 +5 242 243 1041 1123 +5 848 706 1004 1124 +5 224 833 1048 1125 +5 740 774 775 1126 +5 832 892 1002 1127 +5 780 798 889 1128 +5 746 798 1043 1129 +5 812 937 1025 1130 +5 250 249 851 1131 +5 742 789 1052 1132 +5 816 764 898 1133 +5 178 179 892 1134 +5 890 709 1057 1135 +5 224 225 833 1136 +5 965 783 1051 1137 +5 768 897 994 1138 +5 741 780 1010 1139 +5 867 724 1000 1140 +5 732 873 1019 1141 +5 757 815 821 1142 +5 239 240 880 1143 +5 773 743 870 1144 +5 780 889 968 1145 +5 787 739 920 1146 +5 844 938 1010 1147 +5 189 190 898 1148 +5 244 5 966 1149 +5 792 751 804 1150 +5 832 759 892 1151 +5 883 728 1020 1152 +5 813 840 1074 1153 +5 767 867 1134 1154 +5 751 788 804 1155 +5 853 731 948 1156 +5 873 767 1090 1157 +5 711 841 1099 1158 +5 837 721 910 1159 +5 967 863 1086 1160 +5 802 1093 1138 1161 +5 785 886 907 1162 +5 951 857 960 1163 +5 739 787 933 1164 +5 766 1057 1106 1165 +5 227 823 1035 1166 +5 809 822 1141 1167 +5 764 775 820 1168 +5 944 825 1063 1169 +5 883 754 1023 1170 +5 119 120 889 1171 +5 868 767 1134 1172 +5 254 253 871 1173 +5 886 245 907 1174 +5 800 799 901 1175 +5 805 226 1035 1176 +5 773 797 881 1177 +5 785 762 886 1178 +5 853 926 1022 1179 +5 774 759 832 1180 +5 853 718 866 1181 +5 222 223 941 1182 +5 921 848 1004 1183 +5 789 742 909 1184 +5 851 249 913 1185 +5 781 938 974 1186 +5 799 749 1028 1187 +5 910 715 1047 1188 +5 762 714 894 1189 +5 866 730 874 1190 +5 752 882 959 1191 +5 986 782 1060 1192 +5 862 819 966 1193 +5 928 712 937 1194 +5 706 873 1090 1195 +5 898 820 1015 1196 +5 752 792 827 1197 +5 722 859 896 1198 +5 763 894 1074 1199 +5 837 910 1047 1200 +5 863 718 1086 1201 +5 750 778 1093 1202 +5 860 246 886 1203 +5 822 809 902 1204 +5 938 781 1010 1205 +5 791 752 827 1206 +5 982 781 1064 1207 +5 759 808 892 1208 +5 206 207 902 1209 +5 763 784 894 1210 +5 783 743 1051 1211 +5 812 733 850 1212 +5 820 916 1006 1213 +5 818 732 1054 1214 +5 161 162 897 1215 +5 753 791 828 1216 +5 725 942 1066 1217 +5 204 205 919 1218 +5 786 951 960 1219 +5 1057 869 1106 1220 +5 245 0 907 1221 +5 793 753 828 1222 +5 231 232 850 1223 +5 140 141 895 1224 +5 1003 826 1136 1225 +5 236 237 891 1226 +5 754 793 831 1227 +5 142 143 900 1228 +5 795 754 831 1229 +5 768 824 897 1230 +5 144 145 899 1231 +5 225 226 1115 1232 +5 134 135 901 1233 +5 778 750 885 1234 +5 847 768 994 1235 +5 797 977 1083 1236 +5 239 880 933 1237 +5 871 253 909 1238 +5 844 780 968 1239 +5 798 746 1060 1240 +5 870 721 908 1241 +5 788 802 895 1242 +5 721 837 908 1243 +5 124 856 974 1244 +5 941 862 1125 1245 +5 146 147 912 1246 +5 845 822 958 1247 +5 920 739 1055 1248 +5 148 149 911 1249 +5 804 788 900 1250 +5 724 830 1053 1251 +5 150 151 915 1252 +5 942 737 1025 1253 +5 152 153 914 1254 +5 720 811 971 1255 +5 825 944 1036 1256 +5 715 846 1047 1257 +5 154 155 918 1258 +5 156 157 917 1259 +5 202 203 929 1260 +5 811 1026 1130 1261 +5 830 925 1103 1262 +5 856 125 950 1263 +5 827 792 912 1264 +5 181 182 927 1265 +5 877 760 972 1266 +5 199 875 1030 1267 +5 940 823 1081 1268 +5 858 117 953 1269 +5 116 858 952 1270 +5 857 115 952 1271 +5 114 857 951 1272 +5 853 713 926 1273 +5 718 1022 1086 1274 +5 784 763 913 1275 +5 717 904 1005 1276 +5 792 804 899 1277 +5 777 855 1022 1278 +5 813 934 1114 1279 +5 866 738 1080 1280 +5 727 876 1052 1281 +5 791 827 911 1282 +5 811 720 967 1283 +5 774 927 1017 1284 +5 932 751 959 1285 +5 726 877 972 1286 +5 826 742 1052 1287 +5 761 934 970 1288 +5 828 791 915 1289 +5 943 769 1112 1290 +5 740 764 905 1291 +5 780 741 1043 1292 +5 793 828 914 1293 +5 789 839 1052 1294 +5 755 768 961 1295 +5 748 787 920 1296 +5 174 175 931 1297 +5 730 866 1045 1298 +5 831 793 918 1299 +5 803 757 821 1300 +5 888 796 1070 1301 +5 823 227 1081 1302 +5 176 177 930 1303 +5 794 724 1139 1304 +5 795 831 917 1305 +5 2 259 1018 1306 +5 5 220 966 1307 +5 111 112 923 1308 +5 724 794 1000 1309 +5 765 734 1108 1310 +5 231 850 1089 1311 +5 811 717 1026 1312 +5 109 110 922 1313 +5 913 248 1077 1314 +5 763 851 913 1315 +5 743 939 1072 1316 +5 766 890 1057 1317 +5 775 864 916 1318 +5 709 890 1003 1319 +5 863 825 1045 1320 +5 840 813 1101 1321 +5 875 200 981 1322 +5 837 719 1151 1323 +5 843 1095 1105 1324 +5 756 807 1123 1325 +5 885 722 939 1326 +5 790 707 1091 1327 +5 925 867 1062 1328 +5 862 221 1125 1329 +5 873 706 973 1330 +5 137 879 963 1331 +5 256 255 1103 1332 +5 241 242 1070 1333 +5 763 1074 1092 1334 +5 807 737 1123 1335 +5 879 138 962 1336 +5 910 801 1147 1337 +5 856 950 1064 1338 +5 195 196 949 1339 +5 744 874 1036 1340 +5 836 708 1050 1341 +5 861 772 1082 1342 +5 191 192 947 1343 +5 197 198 946 1344 +5 193 194 945 1345 +5 253 252 909 1346 +5 810 770 893 1347 +5 818 940 1018 1348 +5 713 853 948 1349 +5 220 221 862 1350 +5 249 248 913 1351 +5 1003 790 1091 1352 +5 779 928 937 1353 +5 967 716 1102 1354 +5 772 954 1082 1355 +5 773 870 1075 1356 +5 881 797 1083 1357 +5 858 953 1060 1358 +5 758 874 1128 1359 +5 226 227 1035 1360 +5 235 236 924 1361 +5 951 786 975 1362 +5 950 797 1064 1363 +5 229 2 1018 1364 +5 742 871 909 1365 +5 738 874 1094 1366 +5 829 972 1109 1367 +5 730 825 1036 1368 +5 934 714 970 1369 +5 796 888 1146 1370 +5 131 884 965 1371 +5 935 936 937 1372 +5 761 786 1049 1373 +5 884 132 964 1374 +5 739 1050 1055 1375 +5 958 209 1024 1376 +5 725 1044 1123 1377 +5 904 717 1102 1378 +5 251 839 1073 1379 +5 785 761 970 1380 +5 258 835 1113 1381 +5 716 967 1086 1382 +5 747 908 982 1383 +5 743 783 1028 1384 +5 236 891 924 1385 +5 953 798 1060 1386 +5 760 1048 1140 1387 +5 749 800 1085 1388 +5 817 875 981 1389 +5 122 123 938 1390 +5 873 805 1019 1391 +5 228 940 1081 1392 +5 746 986 1060 1393 +5 707 841 954 1394 +5 790 890 1098 1395 +5 830 724 925 1396 +5 737 942 1123 1397 +5 706 848 1088 1398 +5 722 843 939 1399 +5 208 209 958 1400 +5 876 727 1078 1401 +5 759 738 1094 1402 +5 760 877 1048 1403 +5 865 861 1150 1404 +5 955 746 956 1405 +5 747 982 1064 1406 +5 158 878 997 1407 +5 248 247 1077 1408 +5 803 946 1030 1409 +5 238 239 933 1410 +5 168 893 979 1411 +5 960 782 986 1412 +5 878 159 969 1413 +5 243 244 1065 1414 +5 893 169 978 1415 +5 242 888 1070 1416 +5 808 758 814 1417 +5 864 774 1017 1418 +5 856 781 974 1419 +5 880 739 933 1420 +5 769 854 1111 1421 +5 711 777 1150 1422 +5 896 859 1026 1423 +5 259 258 1113 1424 +5 228 229 940 1425 +5 906 256 1103 1426 +5 758 806 814 1427 +5 1066 942 1068 1428 +5 762 785 970 1429 +5 736 960 986 1430 +5 934 761 1049 1431 +5 715 910 1147 1432 +5 728 883 971 1433 +5 909 252 1073 1434 +5 774 832 927 1435 +5 737 807 809 1436 +5 117 118 953 1437 +5 113 114 951 1438 +5 115 116 952 1439 +5 125 126 950 1440 +5 890 790 1003 1441 +5 234 235 936 1442 +5 233 234 935 1443 +5 874 744 1128 1444 +5 716 904 1102 1445 +5 992 887 1038 1446 +5 740 905 1080 1447 +5 764 765 1108 1448 +5 797 773 1075 1449 +5 240 241 1069 1450 +5 252 251 1073 1451 +5 943 944 961 1452 +5 838 773 881 1453 +5 710 926 1067 1454 +5 887 173 1013 1455 +5 794 826 1003 1456 +5 812 233 935 1457 +5 778 885 1085 1458 +5 934 736 1114 1459 +5 136 137 963 1460 +5 734 757 1059 1461 +5 138 139 962 1462 +5 172 887 992 1463 +5 738 759 998 1464 +5 870 747 1075 1465 +5 786 923 975 1466 +5 960 736 1049 1467 +5 982 741 1010 1468 +5 130 131 965 1469 +5 745 1104 1119 1470 +5 833 225 1115 1471 +5 255 254 1126 1472 +5 904 872 1005 1473 +5 132 133 964 1474 +5 200 201 981 1475 +5 759 774 998 1476 +5 788 751 1042 1477 +5 119 889 976 1478 +5 889 120 968 1479 +5 788 895 985 1480 +5 781 982 1010 1481 +5 900 788 985 1482 +5 859 723 1026 1483 +5 877 223 1048 1484 +5 719 1100 1114 1485 +5 814 806 931 1486 +5 207 208 957 1487 +5 727 839 1133 1488 +5 850 845 1089 1489 +5 966 819 1065 1490 +5 859 722 1122 1491 +5 737 809 1141 1492 +5 223 224 1048 1493 +5 1053 742 1139 1494 +5 1018 259 1113 1495 +5 159 160 969 1496 +5 185 916 1007 1497 +5 908 741 982 1498 +5 719 837 1047 1499 +5 751 792 1135 1500 +5 120 121 968 1501 +5 749 939 1028 1502 +5 244 966 1065 1503 +5 751 932 1042 1504 +5 708 921 1124 1505 +5 230 231 1089 1506 +5 926 713 1067 1507 +5 722 896 1095 1508 +5 178 892 1016 1509 +5 167 168 979 1510 +5 916 186 1006 1511 +5 723 859 932 1512 +5 921 772 1124 1513 +5 876 826 1052 1514 +5 792 752 1135 1515 +5 169 170 978 1516 +5 767 868 1090 1517 +5 237 238 1110 1518 +5 838 881 1061 1519 +5 741 908 1151 1520 +5 940 818 1054 1521 +5 910 721 1105 1522 +5 808 814 930 1523 +5 750 932 1122 1524 +5 926 777 1022 1525 +5 1050 865 1055 1526 +5 254 871 1126 1527 +5 774 740 998 1528 +5 786 960 1049 1529 +5 801 896 1005 1530 +5 880 240 1069 1531 +5 892 179 1002 1532 +5 797 950 977 1533 +5 1064 797 1075 1534 +5 733 822 845 1535 +5 746 955 986 1536 +5 235 924 936 1537 +5 803 821 946 1538 +5 959 751 1135 1539 +5 835 818 1113 1540 +5 922 785 1040 1541 +5 925 906 1103 1542 +5 820 775 916 1543 +5 707 954 1134 1544 +5 171 172 992 1545 +5 794 1003 1091 1546 +5 807 756 817 1547 +5 752 791 1009 1548 +5 858 782 952 1549 +5 782 857 952 1550 +5 810 992 1038 1551 +5 912 792 989 1552 +5 762 860 886 1553 +5 841 711 1082 1554 +5 791 753 1009 1555 +5 220 862 966 1556 +5 141 142 985 1557 +5 812 935 937 1558 +5 792 899 989 1559 +5 143 144 984 1560 +5 7 228 1081 1561 +5 184 185 1007 1562 +5 1000 707 1134 1563 +5 972 760 1109 1564 +5 123 124 974 1565 +5 733 1025 1141 1566 +5 802 788 1093 1567 +5 179 180 1002 1568 +5 1074 840 1092 1569 +5 845 958 1024 1570 +5 186 187 1006 1571 +5 937 712 1025 1572 +5 145 146 989 1573 +5 784 913 1077 1574 +5 791 911 990 1575 +5 118 119 976 1576 +5 112 113 975 1577 +5 955 719 1114 1578 +5 238 933 1110 1579 +5 147 148 988 1580 +5 753 793 1020 1581 +5 805 873 973 1582 +5 126 127 977 1583 +5 898 190 1033 1584 +5 915 791 990 1585 +5 721 1072 1105 1586 +5 723 882 1130 1587 +5 149 150 990 1588 +5 162 163 994 1589 +5 793 754 1020 1590 +5 151 152 993 1591 +5 907 0 1040 1592 +5 153 154 995 1593 +5 956 746 1043 1594 +5 155 156 996 1595 +5 890 766 1098 1596 +5 157 158 997 1597 +5 866 718 1045 1598 +5 875 803 1030 1599 +5 793 914 995 1600 +5 189 898 1015 1601 +5 762 894 1137 1602 +5 721 870 1072 1603 +5 918 793 995 1604 +5 754 795 1023 1605 +5 818 1018 1113 1606 +5 1020 728 1132 1607 +5 140 895 991 1608 +5 796 1146 1149 1609 +5 795 755 1023 1610 +5 188 189 1015 1611 +5 719 956 1151 1612 +5 795 917 997 1613 +5 895 141 985 1614 +5 133 134 983 1615 +5 882 1009 1132 1616 +5 801 910 1105 1617 +5 939 843 1072 1618 +5 134 901 983 1619 +5 135 136 987 1620 +5 1 230 1024 1621 +5 809 807 919 1622 +5 205 206 999 1623 +5 1077 860 1137 1624 +5 142 900 985 1625 +5 901 135 987 1626 +5 139 140 991 1627 +5 161 897 1001 1628 +5 900 143 984 1629 +5 227 7 1081 1630 +5 798 953 976 1631 +5 722 885 1122 1632 +5 144 899 984 1633 +5 752 959 1135 1634 +5 882 723 959 1635 +5 899 145 989 1636 +5 782 858 1060 1637 +5 748 779 924 1638 +5 897 162 994 1639 +5 932 750 1042 1640 +5 728 882 1132 1641 +5 708 836 1079 1642 +5 825 730 1045 1643 +5 939 743 1028 1644 +5 935 234 936 1645 +5 709 1003 1136 1646 +5 885 749 1085 1647 +5 1039 776 1062 1648 +5 173 174 1013 1649 +5 1050 739 1149 1650 +5 718 853 1022 1651 +5 1024 230 1089 1652 +5 896 801 1095 1653 +5 724 1053 1139 1654 +5 175 176 1012 1655 +5 781 856 1064 1656 +5 882 728 1056 1657 +5 160 161 1001 1658 +5 146 912 989 1659 +5 0 109 1040 1660 +5 846 715 1104 1661 +5 182 183 1017 1662 +5 177 178 1016 1663 +5 912 147 988 1664 +5 203 204 1011 1665 +5 148 911 988 1666 +5 923 112 975 1667 +5 911 149 990 1668 +5 247 860 1077 1669 +5 221 6 1125 1670 +5 807 817 929 1671 +5 150 915 990 1672 +5 915 151 993 1673 +5 111 923 1071 1674 +5 717 811 1102 1675 +5 736 934 1049 1676 +5 152 914 993 1677 +5 799 964 983 1678 +5 914 153 995 1679 +5 154 918 995 1680 +5 1095 801 1105 1681 +5 918 155 996 1682 +5 789 909 1073 1683 +5 733 845 850 1684 +5 1000 794 1091 1685 +5 156 917 996 1686 +5 735 943 1112 1687 +5 829 921 1079 1688 +5 917 157 997 1689 +5 748 920 1107 1690 +5 908 837 1151 1691 +5 922 110 1071 1692 +5 971 811 1056 1693 +5 921 708 1079 1694 +5 766 872 904 1695 +5 1104 869 1119 1696 +5 857 782 960 1697 +5 845 1024 1089 1698 +5 902 207 957 1699 +5 745 846 1104 1700 +5 709 869 1057 1701 +5 170 171 1014 1702 +5 1146 836 1149 1703 +5 871 830 1126 1704 +5 1078 745 1119 1705 +5 708 861 865 1706 +5 128 129 1061 1707 +5 731 866 1080 1708 +5 891 237 1110 1709 +5 110 111 1071 1710 +5 955 736 986 1711 +5 765 816 852 1712 +5 190 191 1033 1713 +5 944 729 961 1714 +5 198 199 1030 1715 +5 192 193 1031 1716 +5 815 765 852 1717 +5 196 197 1034 1718 +5 194 195 1032 1719 +5 790 1098 1099 1720 +5 209 1 1024 1721 +5 826 876 1136 1722 +5 109 922 1040 1723 +5 206 902 999 1724 +5 768 943 961 1725 +5 852 816 947 1726 +5 796 880 1069 1727 +5 729 883 1144 1728 +5 772 861 1124 1729 +5 891 748 924 1730 +5 180 181 1021 1731 +5 769 943 1145 1732 +5 732 1019 1054 1733 +5 1100 813 1114 1734 +5 815 852 945 1735 +5 847 903 1145 1736 +5 905 764 1108 1737 +5 943 768 1145 1738 +5 753 1020 1132 1739 +5 1072 843 1105 1740 +5 938 123 974 1741 +5 201 202 1027 1742 +5 204 919 1011 1743 +5 843 722 1095 1744 +5 826 794 1139 1745 +5 807 929 1011 1746 +5 919 205 999 1747 +5 821 815 949 1748 +5 940 229 1018 1749 +5 836 1050 1149 1750 +5 823 940 1054 1751 +5 127 128 1083 1752 +5 883 1023 1144 1753 +5 187 188 1029 1754 +5 741 956 1043 1755 +5 1037 776 1117 1756 +5 855 711 1087 1757 +5 931 806 1013 1758 +5 711 849 1087 1759 +5 871 742 1053 1760 +5 181 927 1021 1761 +5 839 851 1133 1762 +5 888 771 1146 1763 +5 122 938 1131 1764 +5 957 208 958 1765 +5 780 844 1010 1766 +5 712 942 1025 1767 +5 129 130 1096 1768 +5 927 182 1017 1769 +5 706 868 1004 1770 +5 953 118 976 1771 +5 919 807 1011 1772 +5 779 748 928 1773 +5 113 951 975 1774 +5 950 126 977 1775 +5 776 906 925 1776 +5 174 931 1013 1777 +5 6 222 1125 1778 +5 728 971 1056 1779 +5 878 795 997 1780 +5 931 175 1012 1781 +5 712 928 1068 1782 +5 776 925 1062 1783 +5 830 871 1053 1784 +5 894 714 1074 1785 +5 906 776 1037 1786 +5 176 930 1012 1787 +5 870 743 1072 1788 +5 723 932 959 1789 +5 202 929 1027 1790 +5 767 1039 1062 1791 +5 930 177 1016 1792 +5 744 1036 1046 1793 +5 972 829 1058 1794 +5 896 717 1005 1795 +5 929 203 1011 1796 +5 709 876 1119 1797 +5 840 745 1078 1798 +5 824 969 1001 1799 +5 926 710 1076 1800 +5 163 164 1121 1801 +5 839 789 1073 1802 +5 882 1056 1130 1803 +5 822 957 958 1804 +5 811 967 1102 1805 +5 943 735 944 1806 +5 165 166 1116 1807 +5 710 920 1055 1808 +5 164 165 1118 1809 +5 905 734 948 1810 +5 738 998 1080 1811 +5 121 122 1131 1812 +5 964 133 983 1813 +5 1025 737 1141 1814 +5 136 963 987 1815 +5 802 962 991 1816 +5 773 838 1051 1817 +5 904 716 980 1818 +5 903 847 1118 1819 +5 962 139 991 1820 +5 808 930 1016 1821 +5 130 965 1096 1822 +5 736 955 1114 1823 +5 770 1046 1112 1824 +5 854 903 1116 1825 +5 854 769 903 1826 +5 770 810 1127 1827 +5 1022 855 1086 1828 +5 166 167 1142 1829 +5 183 184 1143 1830 +5 883 729 1063 1831 +5 813 1100 1101 1832 +5 777 926 1076 1833 +5 838 1061 1096 1834 +5 968 121 1131 1835 +5 874 730 1036 1836 +5 769 1111 1112 1837 +5 868 954 1004 1838 +5 787 891 1110 1839 +5 973 706 1088 1840 +5 954 868 1134 1841 +5 851 763 1133 1842 +5 869 709 1119 1843 +5 747 1064 1075 1844 +5 1069 241 1070 1845 +5 848 1109 1140 1846 +5 785 907 1040 1847 +5 1019 805 1035 1848 +5 191 947 1033 1849 +5 719 955 956 1850 +5 947 192 1031 1851 +5 742 826 1139 1852 +5 195 949 1032 1853 +5 707 1000 1091 1854 +5 193 945 1031 1855 +5 1103 255 1126 1856 +5 880 796 1149 1857 +5 949 196 1034 1858 +5 945 194 1032 1859 +5 921 829 1109 1860 +5 946 198 1030 1861 +5 197 946 1034 1862 +5 963 800 987 1863 +5 905 731 1080 1864 +5 889 798 976 1865 +5 936 779 937 1866 +5 969 160 1001 1867 +5 1036 735 1046 1868 +5 977 127 1083 1869 +5 1008 734 1059 1870 +5 806 887 1013 1871 +5 846 745 1101 1872 +5 806 758 1128 1873 +5 992 810 1014 1874 +5 842 928 1107 1875 +5 766 904 980 1876 +5 718 863 1045 1877 +5 708 865 1050 1878 +5 810 978 1014 1879 +5 801 1005 1147 1880 +5 875 817 1084 1881 +5 758 808 1094 1882 +5 971 883 1063 1883 +5 868 706 1090 1884 +5 1044 725 1059 1885 +5 745 840 1101 1886 +5 731 905 948 1887 +5 901 799 983 1888 +5 867 1000 1134 1889 +5 924 779 936 1890 +5 998 740 1080 1891 +5 942 712 1068 1892 +5 956 741 1151 1893 +5 1019 823 1054 1894 +5 933 787 1110 1895 +5 167 979 1142 1896 +5 978 170 1014 1897 +5 948 734 1008 1898 +5 1058 771 1097 1899 +5 128 1061 1083 1900 +5 885 750 1122 1901 +5 947 816 1033 1902 +5 842 710 1067 1903 +5 1061 129 1096 1904 +5 932 859 1122 1905 +5 822 733 1141 1906 +5 860 762 1137 1907 +5 1118 847 1121 1908 +5 171 992 1014 1909 +5 717 896 1026 1910 +5 1041 243 1065 1911 +5 808 759 1094 1912 +5 867 767 1062 1913 +5 835 1037 1117 1914 +5 876 1078 1119 1915 +5 815 945 1032 1916 +5 894 784 1137 1917 +5 796 1069 1070 1918 +5 994 163 1121 1919 +5 222 941 1125 1920 +5 757 803 1044 1921 +5 949 815 1032 1922 +5 716 1086 1087 1923 +5 920 710 1107 1924 +5 892 808 1016 1925 +5 823 1019 1035 1926 +5 832 1002 1021 1927 +5 954 772 1004 1928 +5 771 1058 1120 1929 +5 1038 806 1128 1930 +5 876 709 1136 1931 +5 755 961 1144 1932 +5 903 769 1145 1933 +5 981 201 1027 1934 +5 1008 725 1066 1935 +5 942 725 1123 1936 +5 810 1038 1127 1937 +5 1002 180 1021 1938 +5 1026 723 1130 1939 +5 840 1078 1092 1940 +5 805 973 1115 1941 +5 784 1077 1137 1942 +5 788 1042 1093 1943 +5 980 716 1087 1944 +5 757 1044 1059 1945 +5 184 1007 1143 1946 +5 726 972 1058 1947 +5 776 1039 1117 1948 +5 1079 836 1120 1949 +5 1006 187 1029 1950 +5 854 1116 1142 1951 +5 1046 770 1127 1952 +5 1044 803 1084 1953 +5 188 1015 1029 1954 +5 1015 820 1029 1955 +5 1120 836 1146 1956 +5 965 838 1096 1957 +5 1078 727 1092 1958 +5 1039 732 1117 1959 +5 820 1006 1029 1960 +5 1046 735 1112 1961 +5 888 1041 1148 1962 +5 844 968 1131 1963 +5 895 802 991 1964 +5 830 1103 1126 1965 +5 1017 183 1143 1966 +5 763 1092 1133 1967 +5 766 980 1098 1968 +5 962 802 1138 1969 +5 164 1118 1121 1970 +5 771 888 1148 1971 +5 165 1116 1118 1972 +5 897 824 1001 1973 +5 710 842 1107 1974 +5 887 806 1038 1975 +5 928 748 1107 1976 +5 800 901 987 1977 +5 1082 711 1150 1978 +5 1109 760 1140 1979 +5 713 948 1008 1980 +5 923 834 1071 1981 +5 719 1047 1100 1982 +5 816 898 1033 1983 +5 819 1041 1065 1984 +5 1116 166 1142 1985 +5 800 963 1129 1986 +5 1085 800 1129 1987 +5 834 922 1071 1988 +5 725 1008 1059 1989 +5 833 973 1088 1990 +5 1009 753 1132 1991 +5 710 1055 1076 1992 +5 1058 829 1120 1993 +5 848 921 1109 1994 +5 804 900 984 1995 +5 1100 846 1101 1996 +5 899 804 984 1997 +5 817 756 1084 1998 +5 938 844 1131 1999 +5 1104 715 1106 2000 +5 1041 819 1148 2001 +5 1106 715 1147 2002 +5 739 880 1149 2003 +5 768 847 1145 2004 +5 833 1088 1140 2005 +5 861 708 1124 2006 +5 819 1097 1148 2007 +5 1023 755 1144 2008 +5 827 912 988 2009 +5 911 827 988 2010 +5 842 1066 1068 2011 +5 817 981 1027 2012 +5 744 1038 1128 2013 +5 847 994 1121 2014 +5 828 915 993 2015 +5 914 828 993 2016 +5 720 971 1063 2017 +5 831 918 996 2018 +5 917 831 996 2019 +5 1097 771 1148 2020 +5 879 778 1129 2021 +5 778 879 1138 2022 +5 734 905 1108 2023 +5 771 1120 1146 2024 +5 1038 744 1127 2025 +5 756 1044 1084 2026 +5 778 1085 1129 2027 +5 973 833 1115 2028 +5 1086 855 1087 2029 +5 927 832 1021 2030 +5 1098 849 1099 2031 +5 822 902 957 2032 +5 963 879 1129 2033 +5 1088 848 1140 2034 +5 713 1066 1067 2035 +5 1066 842 1067 2036 +5 879 962 1138 2037 +5 726 1058 1097 2038 +5 979 854 1142 2039 +5 1061 881 1083 2040 +5 928 842 1068 2041 +5 803 875 1084 2042 +5 961 729 1144 2043 +5 872 1106 1147 2044 +5 1005 872 1147 2045 +5 829 1079 1120 2046 +5 864 1017 1143 2047 +5 744 1046 1127 2048 +5 814 931 1012 2049 +5 930 814 1012 2050 +5 854 979 1111 2051 +5 902 809 999 2052 +5 929 817 1027 2053 +5 1042 750 1093 2054 +5 849 980 1087 2055 +5 979 893 1111 2056 +5 809 919 999 2057 +5 980 849 1098 2058 +5 1111 770 1112 2059 +5 1007 864 1143 2060 +5 893 770 1111 2061 +5 713 1008 1066 2062 +5 1056 811 1130 2063 +5 1047 846 1100 2064 +5 869 1104 1106 2065 +5 1055 865 1076 2066 +5 852 947 1031 2067 +5 945 852 1031 2068 +5 861 1082 1150 2069 +5 1092 727 1133 2070 +5 821 949 1034 2071 +5 946 821 1034 2072 +5 1116 903 1118 2073 +NPOIN= 1152 +1 -0 0 +0 0 1 +6 0 2 +6 5 3 +-5 5 4 +-5 0 5 +-5 -5 6 +6 -5 7 +0.002928006758103981 0.009416175637099185 8 +0.009656657227709597 0.01675583339068025 9 +0.0178900372921703 0.02240743722335979 10 +0.0267774127157938 0.02697718867355284 11 +0.03600738974797691 0.03081370531484433 12 +0.04544239753676235 0.03411656531267509 13 +0.05501171022513591 0.03700869912607993 14 +0.06467473620147671 0.0395711823368722 15 +0.07440621459968758 0.04186051999197819 16 +0.08418944114219648 0.04391788081062413 17 +0.09401282066603836 0.045774343427975 18 +0.1038679982148655 0.04745404192685047 19 +0.1137487498281008 0.04897625900196905 20 +0.1236503319920059 0.05035662472091704 21 +0.1335690369638252 0.05160813401714554 22 +0.1435019264494771 0.05274167275476024 23 +0.1534466235471236 0.05376654797408723 24 +0.1634011847801887 0.05469077539896083 25 +0.1733640046254436 0.0555213406537459 26 +0.1833337363109601 0.05626439081900574 27 +0.1933092485940546 0.05692537713293608 28 +0.2032895790171535 0.05750917355542325 29 +0.2132739050797371 0.05802016636025917 30 +0.2232615175064552 0.05846232599897122 31 +0.2332518051955813 0.05883926065533289 32 +0.243244239567849 0.0591542690795365 33 +0.2532383586677003 0.05941038718110982 34 +0.2632337585207202 0.05961041524066159 35 +0.2732300876820112 0.05975694569022227 36 +0.2832270346849036 0.05985238645526399 37 +0.2932243303346729 0.05989898098354966 38 +0.3032217354005093 0.05989882518107176 39 +0.3132190401921424 0.05985388208001308 40 +0.3232160603313082 0.05976599444659998 41 +0.3332126337006116 0.05963689571401102 42 +0.3432086180918308 0.05946821949009216 43 +0.3532038893600204 0.0592615078526036 44 +0.3631983365879528 0.05901821869842145 45 +0.3731918659165012 0.0587397320313871 46 +0.3831843937347973 0.05842735574449518 47 +0.3931758478776778 0.05808233058557523 48 +0.4031661655995394 0.05770583465203951 49 +0.4131552938564177 0.05729898733201109 50 +0.4231431866892663 0.05686285294369792 51 +0.4331298046959815 0.05639844394881362 52 +0.4431151156060446 0.05590672379376958 53 +0.4530990921250435 0.05538860960293635 54 +0.4630817114294976 0.05484497456399326 55 +0.4730629559834303 0.05427665002227133 56 +0.4830428111436978 0.05368442756115005 57 +0.4930212660713544 0.05306906073342802 58 +0.50299831277193 0.0524312667439962 59 +0.5129739457048144 0.05177172796547173 60 +0.5229481616008261 0.05109109331591759 61 +0.5329209589825804 0.05038997954368631 62 +0.5428923378595487 0.04966897239935829 63 +0.5528622999174178 0.04892862767761611 64 +0.5628308471145159 0.0481694722919123 65 +0.5727979830142073 0.04739200544768309 66 +0.5827637117764652 0.04659670006711249 67 +0.5927280369229947 0.04578400106081556 68 +0.6026909631998449 0.04495432738308695 69 +0.6126524947821477 0.0441080730229547 70 +0.6226126358091321 0.04324560758444296 71 +0.6325713909792378 0.04236727681044843 72 +0.6425287626929798 0.04147340337271171 73 +0.6524847541391261 0.04056428710465356 74 +0.6624393681487185 0.03964020556963967 75 +0.6723926053443589 0.03870141467944301 76 +0.6823444668457874 0.0377481488665258 77 +0.692294952164642 0.03678062168599276 78 +0.702244059544721 0.03579902618109438 79 +0.7121917860635467 0.03480353526452736 80 +0.7221381273651238 0.03379430214001172 81 +0.7320830926247791 0.0327714581288852 82 +0.742026632542362 0.03173511846657081 83 +0.7519687807848738 0.03068537264756371 84 +0.7619095119163884 0.02962229778547494 85 +0.7718488144997528 0.02854595135758193 86 +0.7817866764191757 0.02745637332744551 87 +0.7917230800430328 0.02635358745963126 88 +0.8016580111699132 0.02523760136885789 89 +0.8115914479865283 0.02410840254193586 90 +0.8215233690303224 0.02296594028598689 91 +0.8314537498542579 0.02181016951298297 92 +0.8413825663926249 0.02064103768652176 93 +0.8513097900796052 0.01945847038026751 94 +0.8612353908302575 0.01826233230951072 95 +0.8711593344919348 0.01705253592751455 96 +0.8810815872552576 0.01582895112988503 97 +0.8910021087500093 0.01459140293013438 98 +0.9009208604680121 0.01333976347266454 99 +0.9108377996228046 0.01207382494591028 100 +0.9207528772335959 0.01079339116130297 101 +0.9306660464843619 0.009498274692102 102 +0.9405772554496891 0.008188232328229917 103 +0.950486446734735 0.00686301972225717 104 +0.9603935629035422 0.005522385242069535 105 +0.9702985449752203 0.004166067242661914 106 +0.9802013243635839 0.002793761878333214 107 +0.9901018394648315 0.001405178298830974 108 +0.9901018393717245 -0.00140517831196949 109 +0.9802013242250642 -0.002793761897645462 110 +0.9702985447813979 -0.004166067269362605 111 +0.9603935626696426 -0.00552238527390729 112 +0.9504864464485938 -0.006863019760751762 113 +0.9405772551180019 -0.008188232372330823 114 +0.9306660460881218 -0.00949827474417375 115 +0.9207528767707699 -0.01079339122141971 116 +0.9108377991001509 -0.01207382501301059 117 +0.900920859899052 -0.01333976354487936 118 +0.8910021081322407 -0.01459140300764024 119 +0.8810815865645449 -0.01582895121555643 120 +0.8711593337525039 -0.01705253601817095 121 +0.8612353900436598 -0.01826233240485476 122 +0.8513097892311642 -0.01945847048192335 123 +0.841382565491897 -0.02064103779319749 124 +0.8314537489032577 -0.02181016962431793 125 +0.8215233680178065 -0.02296594040314517 126 +0.8115914469241106 -0.02410840266342293 127 +0.8016580100547996 -0.02523760149486375 128 +0.7917230788753313 -0.02635358759001435 129 +0.7817866751956606 -0.02745637346241789 130 +0.7718488132190773 -0.02854595149713655 131 +0.7619095105773799 -0.02962229792957867 132 +0.7519687793899199 -0.03068537279579783 133 +0.7420266310902506 -0.0317351186189011 134 +0.7320830911105478 -0.03277145828565707 135 +0.7221381257883078 -0.03379430230108972 136 +0.712191784430087 -0.03480353542912704 137 +0.7022440578500121 -0.0357990263494916 138 +0.6922949504129563 -0.03678062185756865 139 +0.6823444650372734 -0.03774814904107126 140 +0.6723926034804633 -0.03870141485661948 141 +0.6624393662288377 -0.03964020574929943 142 +0.6524847521686397 -0.04056428728608744 143 +0.6425287606660026 -0.04147340355624666 144 +0.6325713888929572 -0.04236727699610189 145 +0.6226126336731447 -0.04324560777112467 146 +0.612652492591527 -0.04410807321085617 147 +0.6026909609517253 -0.04495432757219156 148 +0.5927280346157944 -0.0457840012509747 149 +0.5827637094113137 -0.04659670025793819 150 +0.5727979805941229 -0.04739200563863082 151 +0.5628308446357866 -0.04816947248296408 152 +0.5528622973770939 -0.04892862786866557 153 +0.5428923352656319 -0.04966897258945614 154 +0.5329209563372319 -0.05038997973233004 155 +0.5229481588973779 -0.0510910935032128 156 +0.5129739429466047 -0.05177172815079268 157 +0.5029983099536141 -0.05243126692728397 158 +0.4930212632769525 -0.05306906090895496 159 +0.4830428084033003 -0.05368442772700793 160 +0.4730629532933383 -0.05427665017872569 161 +0.4630817087926128 -0.05484497471091702 162 +0.4530990895454926 -0.05538860974016091 163 +0.4431151130812384 -0.05590672392150109 164 +0.4331298022253228 -0.05639844406714616 165 +0.4231431842754723 -0.056862853052575 166 +0.4131552914979834 -0.05729898743158218 167 +0.4031661632927094 -0.0577058347425342 168 +0.3931758456240363 -0.05808233066700064 169 +0.383184391543939 -0.05842735581661442 170 +0.3731918637775558 -0.05873973209466998 171 +0.3631983345036391 -0.05901821875287923 172 +0.3532038873279049 -0.05926150789839853 173 +0.3432086161175891 -0.05946821952721376 174 +0.3332126317810793 -0.05963689574265311 175 +0.3232160584673244 -0.0597659944668838 176 +0.313219038384463 -0.0598538820920793 177 +0.3032217336477285 -0.05989882518508514 178 +0.2932243286392444 -0.05989898097967465 179 +0.2832270330418884 -0.05985238644365778 180 +0.2732300860945435 -0.05975694567107745 181 +0.2632337569875509 -0.05961041521415349 182 +0.2532383571886921 -0.05941038714743063 183 +0.2432442381427626 -0.05915426903888508 184 +0.2332518038284884 -0.0588392606080653 185 +0.2232615161917042 -0.05846232594513658 186 +0.2132739038187381 -0.05802016630015731 187 +0.2032895778131825 -0.05750917348948716 188 +0.193309247446509 -0.05692537706144653 189 +0.1833337352187804 -0.05626439074221811 190 +0.1733640035880945 -0.05552134057195171 191 +0.1634011837980877 -0.05469077531254326 192 +0.1534466226212033 -0.05376654788351259 193 +0.1435019255803366 -0.05274167266051431 194 +0.1335690361505607 -0.05160813391957707 195 +0.1236503312351367 -0.05035662462057006 196 +0.1137487491287153 -0.04897625889952584 197 +0.1038679975727208 -0.04745404182286536 198 +0.09401282007927704 -0.04577434332276073 199 +0.08418944061208598 -0.04391788070506909 200 +0.07440621412557863 -0.04186051988668395 201 +0.06467473578313843 -0.03957118223259374 202 +0.05501170986415309 -0.03700869902416742 203 +0.04544239723297768 -0.03411656521425388 204 +0.03600738950175719 -0.03081370522148734 205 +0.02677741252664324 -0.02697718858697657 206 +0.01789003716024659 -0.02240743714646207 207 +0.009656657152657741 -0.01675583332863176 208 +0.002928006731854051 -0.009416175595907249 209 +6 1.666666666663134 210 +6 3.3333333333308 211 +4.428571428577774 5 212 +2.857142857155548 5 213 +1.285714285733324 5 214 +-0.2857142856952475 5 215 +-1.857142857130165 5 216 +-3.428571428565082 5 217 +-5 3.333333333333332 218 +-5 1.666666666666666 219 +-5 -1.666666666663134 220 +-5 -3.3333333333308 221 +-3.428571428577774 -5 222 +-1.857142857155548 -5 223 +-0.2857142857333237 -5 224 +1.285714285695247 -5 225 +2.857142857130165 -5 226 +4.428571428565082 -5 227 +6 -3.333333333333332 228 +6 -1.666666666666666 229 +-0.01133647538991137 0 230 +-0.02694823954186591 0 231 +-0.0484476107333601 0 232 +-0.07805497469099948 0 233 +-0.1188280684439929 0 234 +-0.1749777797895224 0 235 +-0.2523030544064367 0 236 +-0.3587897451608424 0 237 +-0.505435422232934 0 238 +-0.707385081535382 0 239 +-0.9854954083256572 0 240 +-1.368488487079123 0 241 +-1.895918559507216 0 242 +-2.622256544614949 0 243 +-3.622516122497196 0 244 +1.01133647538987 0 245 +1.026948239541752 0 246 +1.048447610733208 0 247 +1.078054974690832 0 248 +1.11882806844382 0 249 +1.174977779789288 0 250 +1.252303054405882 0 251 +1.358789745160228 0 252 +1.505435422232292 0 253 +1.707385081534587 0 254 +1.985495408324234 0 255 +2.368488487078613 0 256 +2.895918559508627 0 257 +3.622256544616668 0 258 +4.62251612249838 0 259 +1.13302246388969 2.292574799190077 260 +1.06151512689784 1.013283456935835 261 +-0.2904411687890602 1.203553440708984 262 +1.019077481608153 0.3818937199343506 263 +-0.1055771862288109 0.3875866048457747 264 +0.500143993654707 0.7052591428095324 265 +-0.05353041311515772 0.1305202121575376 266 +0.1057296635970441 0.2859009870329634 267 +1.005809878727725 0.07443301042381663 268 +0.8842093287490111 0.2058472825688651 269 +0.5996030533428337 0.3777284774421438 270 +0.6847565656806244 0.2230188821957469 271 +0.3553760563042578 0.3169520999786504 272 +0.9116874268872323 0.1054562447778652 273 +0.5181048398506898 0.218268997269903 274 +0.8284547486803152 0.1153845497598563 275 +0.7339522170469351 0.1289253077048416 276 +0.6479641648899798 0.1354177088315514 277 +1.584858064760476 0.6456028757759052 278 +0.05908752535420028 0.151063480069773 279 +-2.330770529940587 2.377617614782642 280 +1.141741183689912 0.1765917078116667 281 +0.5650137051445806 0.1334788679506854 282 +0.4844542493305946 0.134578735982285 283 +0.3739490706080427 0.1833101083254173 284 +0.2338691242939676 0.1979005160140496 285 +3.110513643562834 1.928504795052857 286 +-0.02526323728154631 0.04283409288011156 287 +0.1438372130433808 0.1458285039800687 288 +0.4192862950630746 0.1209772915811707 289 +0.9503466110006695 0.06198023234027444 290 +0.01019599171007079 0.08145121387148829 291 +0.2942832506587635 0.1409089375455686 292 +-0.5498305332553146 0.426588352323415 293 +0.2331891040154371 0.1187871168254803 294 +0.8738096535137887 0.06957207605308914 295 +1.399462825944659 0.2723248278005079 296 +0.7831234824545921 0.07649975077249016 297 +0.3706899052072464 0.1153976388822008 298 +1.00005944762781 0.2064122663239836 299 +0.9110344068184399 0.05533493835058036 300 +0.8316987761375391 0.06815606422968555 301 +-0.2401232270179954 0.1816215807440987 302 +0.7413919907858405 0.07386745108158417 303 +0.6929395817953934 0.08879550331489253 304 +0.6512459687765729 0.08196800396861717 305 +0.6129215430683459 0.08730680613791263 306 +0.5712878220930374 0.08563017009723477 307 +0.5295254244694896 0.09069768804043651 308 +0.4893580137297853 0.0896827884806501 309 +0.0585949820235368 0.08361260032898674 310 +0.117484092412607 0.1020006368166562 311 +0.3301102580669673 0.1007963008378184 312 +0.287177439582124 0.09955828612411427 313 +-0.7597713819212539 3.10643877403372 314 +0.9801076053982611 0.03853365902553563 315 +1.02005436434545 0.04171659612577184 316 +1.08728780659262 0.0790967322240224 317 +0.1942275785780455 0.10092963263906 318 +0.1546005674119475 0.09540861240559871 319 +0.8130277763527149 0.4054362972130897 320 +1.846723117884979 1.575422411528125 321 +0.46312801538596 0.08413447012884882 322 +0.4295229059340843 0.08644391570546919 323 +0.3974270022364975 0.08922199371293932 324 +-1.677242151149075 1.264305657564464 325 +0.4288539573235083 1.444973189709821 326 +0.8008008064806958 0.05800778330517155 327 +0.2581158074022648 0.09057780374720649 328 +0.2280374907112482 0.0898480285093351 329 +2.461414422616189 0.8876906913885255 330 +0.1737994253979854 0.5791547368901857 331 +0.7070640279048819 0.06886954192923712 332 +-0.1605722769809821 0.1100725685547123 333 +0.8801974617867946 0.0427924168859343 334 +0.8488558268581877 0.04280384584220594 335 +0.9290091256672502 0.03540234581945267 336 +0.7691147101269245 0.05465015493854475 337 +1.064587492245793 0.04618852533052858 338 +0.9981471486316704 0.02453875348039187 339 +0.9595236063961223 0.02855777414181924 340 +-0.4051172187244655 0.2155844326374501 341 +0.6691261580638682 0.063750763356324 342 +1.316880088026782 0.1556588994094925 343 +0.9577693265290435 0.7021166328053197 344 +0.5897554536587585 0.07082936388594926 345 +0.6297636831267598 0.06742942913741728 346 +0.5496287884216455 0.07374904240615922 347 +1.301281933304072 0.6104294380345541 348 +0.5122063532804868 0.07706191275862144 349 +-1.216663474589873 0.5209769223852861 350 +0.8162699453060546 0.04397103228128969 351 +0.8984586739439698 0.03568332528832772 352 +0.7492694656812243 0.05275854084491759 353 +0.7302277501350587 0.05349866960293821 354 +0.7891775006215969 0.1880392902997836 355 +0.6872202388981558 0.05634740850521722 356 +0.09733205755431208 0.07575212271803998 357 +0.6492740383444964 0.06148872918919117 358 +2.370854501983509 3.527309653211712 359 +0.3454333574983495 0.0840731432556223 360 +0.04190198293544001 0.06310810976997616 361 +0.3112618876904416 0.08582666951820124 362 +0.0200178896103681 0.05101929114567424 363 +0.3817145798379198 0.07920226529131376 364 +0.6046819665726718 0.2099785399314386 365 +-0.05791826978886722 0.03611800931562686 366 +0.9895344245547473 0.109420867872677 367 +0.3286455466436663 0.08047343167796611 368 +0.1359931144208462 0.0769794442942375 369 +0.1729642272480892 0.07899477539240199 370 +0.06615758179187613 0.06266205692061869 371 +3.907648191140519 1.405269814324669 372 +-2.857502566562559 1.374952339557837 373 +0.207181667528759 0.07925910704920776 374 +0.1170425286182623 0.07283124361399557 375 +-0.0006975758003872066 0.03776751952666425 376 +4.090059448682117 3.391833036038689 377 +0.4812251853584687 0.07216630687382836 378 +0.438747456598642 0.1885486372385262 379 +1.230905635401115 0.3801522618598457 380 +0.609701985743359 0.065267773697815 381 +0.5694412494957459 0.06767010100769572 382 +-0.8889793247290261 1.981082587013677 383 +1.846440244929411 0.3460888463873272 384 +0.5295747976646002 0.07103930757886651 385 +0.2796486587267921 0.07905306651144256 386 +0.5857582139807973 3.819323249990164 387 +0.9779324853290154 0.02190231366265215 388 +3.380471892892676 0.5944742573293826 389 +-0.8206605323532397 1.089445630761114 390 +0.8732680786682926 0.1188010834221004 391 +0.7911206247767368 0.04363243520362642 392 +1.213857600572033 0.09591201115106979 393 +1.028240155438465 0.1542857639059146 394 +0.7635684748247666 0.9103737074630562 395 +-0.06249791533909828 0.2633518260139368 396 +0.7798354747526326 0.12837894854228 397 +0.8693057566920546 0.03396200012410924 398 +-0.01509644689946403 0.02298424494939862 399 +0.9388593701648433 0.1788434915454437 400 +0.4478756972734705 0.0723130322331889 401 +0.3336030096476531 2.36016207123301 402 +0.6612707580766438 0.5855987724315176 403 +-0.03213602695183203 0.01855080703030039 404 +1.138988651200216 0.05267055242923233 405 +0.1565401628443353 0.07451784355428777 406 +0.2220414242233417 0.2985116695364243 407 +0.4205565626378998 0.07251533873625862 408 +0.4019812872370888 0.5198358753823983 409 +0.8380825727585488 0.03536059435247824 410 +0.9364769619653224 0.02119050760409333 411 +0.9176164089808548 0.02553512277570686 412 +0.6912620662332999 0.1404906652566503 413 +1.037697925137481 0.02211413446250176 414 +0.1353176588439702 1.069145155279896 415 +-3.790632077994732 2.519243280699331 416 +0.447839327091768 0.2848793682754086 417 +0.2429809326003718 0.07640958692486448 418 +-0.08049320917425022 0.8034558104785036 419 +0.3086601608555733 0.2118255534081687 420 +1.650244869058424 1.075160807541345 421 +1.236424331475819 1.711100854176969 422 +0.9517066602487255 0.3177360650804905 423 +0.8102803045308137 0.08185224381802185 424 +1.606410251883439 0.1887541462054981 425 +0.7902710312069767 0.3010281255835678 426 +2.109252983750392 2.384861524848851 427 +0.3406458853239016 0.1384745876154434 428 +0.08542877452821207 0.06067835678063776 429 +1.103889454407912 0.2767588188805672 430 +-1.763015826066801 3.575794497756287 431 +0.4988968680768504 0.06662678427251589 432 +0.7086271496050629 0.04938338090606065 433 +-0.8464402449305194 0.2870880367006062 434 +0.8026524147302171 0.04232325516900104 435 +0.6055145252937473 0.1246016758346304 436 +0.5236090385562339 0.1260685294351983 437 +0.7677364815726864 0.03798538954742505 438 +0.7232851153312041 0.09154632160220119 439 +1.01914235746581 0.01746422047332786 440 +0.3576240922059224 0.0719375197391996 441 +-1.799745755607382 0.6206627266293133 442 +0.8875531912348296 0.02732551364798142 443 +0.931523670126591 0.5064497247449111 444 +-0.311397407215848 0.09683997445926709 445 +0.2958537053419283 0.07469544941406421 446 +0.3987170968008594 0.07238457970177815 447 +1.040387502346976 0.06572373992824224 448 +0.6782064860268222 0.04925639277216821 449 +0.7258232564924733 0.1813078188684871 450 +0.4696099359337832 0.0654066198587113 451 +0.1894864059873485 0.0720714162018799 452 +0.638612714506211 0.05375767391483492 453 +0.6585605897686433 0.05193608136494187 454 +0.73826036706108 0.04321616907834968 455 +0.01629934343201721 0.03548979020463287 456 +0.4349326566668784 0.07435074624953965 457 +0.7070937736107564 0.3254126735879103 458 +0.1969739126178909 0.1497513627001038 459 +2.346964044558769 0.4705428779959009 460 +1.005668237694938 0.01223361414161445 461 +0.8483172696692534 0.0899480012163007 462 +1.415420788838409 0.1137281915087441 463 +0.8446223251420184 0.1655506041012036 464 +0.5986846882305695 0.05707946442321681 465 +0.6186462710372552 0.05538357276568628 466 +1.094802225992296 0.03181971502342999 467 +0.5587390274722989 0.06026795437833634 468 +0.57871576874053 0.05870956652039277 469 +0.2277038641993942 0.07330214598270611 470 +0.5187617427850965 0.06316493945259639 471 +0.5387547974195563 0.0617592002531947 472 +0.03625995699786772 0.04521975162961236 473 +-0.2870383622306695 0.3410377705619715 474 +-0.07155142225531964 1.75900959558836 475 +0.9866579423720525 0.01283972705329202 476 +0.9668259039171095 0.01527748165879237 477 +-0.2136404170979796 0.06311848999783667 478 +2.001447078832317 0.6893951187985492 479 +0.08567014004547997 0.4276000406854845 480 +0.268050203000933 0.07208065286669747 481 +-0.1145972366805167 0.1791582594496971 482 +0.05652320147614489 0.05080961545679377 483 +0.318322755079963 0.07177674913093697 484 +0.3384125156109294 0.07151681901412901 485 +0.670257865800326 0.1068647699535222 486 +-0.5743868473959173 0.1701847858867569 487 +0.9781352426454757 0.0661032177649527 488 +-0.09857779329100058 0.03164309094785358 489 +-0.1440890574878669 0.0457740159499467 490 +-0.09366041957729443 0.0874843687348022 491 +0.8577583201793935 0.02943332811645872 492 +0.7600804821670666 0.09728734385462894 493 +4.857042312021381 2.33763147340176 494 +-3.019311024620507 3.713396362354023 495 +0.003604208914400304 0.1318822550689858 496 +0.4423877805139588 0.1052638036688772 497 +0.4479705510736774 0.144407983995429 498 +0.1472329490794243 0.06529909889560022 499 +0.1077971634319973 0.05994682985693268 500 +0.1673770954386036 0.0671672512512939 501 +0.1680491726514683 0.2124357500359138 502 +0.1270812860302304 0.06309554011634651 503 +0.8263417295763708 0.0342818369102235 504 +0.9480810050548849 0.01944718040984095 505 +0.9269042840662771 0.02048392841053157 506 +0.9062437587985936 0.02479290943025133 507 +0.8533807106699989 1.310066282595386 508 +0.9264092954706178 0.07464593313649895 509 +0.8997974818461942 0.07927960270719069 510 +0.008207822827023318 0.0266417694026817 511 +-0.001090103584727508 0.0204278786269102 512 +0.6346541003097081 0.1046160087126038 513 +0.9448104348750328 0.03703494155716319 514 +0.4705602851861277 0.1102976958483331 515 +0.698225469973256 0.04597914058153312 516 +0.718147823848335 0.04398541405345203 517 +0.757985219948496 0.04092912982447846 518 +0.7791736964830843 0.04068586271487091 519 +-3.898839516768426 1.003071435800479 520 +0.5586386208504268 0.2913993460117125 521 +0.8763950095192359 0.02652560857273668 522 +0.4869512642848734 0.06164890734476221 523 +0.9964508479497163 0.04906504736409373 524 +0.5469680984374257 0.1732725574325053 525 +-1.293216533142699 2.557392029792528 526 +1.425088657506259 3.103943197222502 527 +0.847384892573105 0.02876938421057993 528 +0.9567756033679089 0.01495245591359985 529 +0.896835718639083 0.02314658295387188 530 +0.8172228009764001 0.03195964635211405 531 +0.3874706433236467 0.0673787606453314 532 +0.4104272743311578 0.06728171704824207 533 +0.686971459862956 0.4577477311648143 534 +0.07627730833086908 0.05262058445896246 535 +0.8512344852640945 0.06379115889185005 536 +0.7479020932036073 0.03986486617237606 537 +0.6482921718902914 0.04984403498926665 538 +0.6681450414704823 0.04865697154850335 539 +0.929949956636362 0.05226768005942919 540 +0.7281714322068753 0.04145320260072737 541 +0.6084752805986353 0.05335864225855195 542 +0.6283896637702355 0.0518504208916036 543 +0.5885295318658635 0.05579981919149738 544 +0.6876583227817327 0.04522234248228742 545 +0.3698367846610512 0.07081881103327504 546 +0.5685126460674166 0.05663415731478673 547 +0.4575496687561061 0.06589583767697355 548 +0.5485754502180934 0.05887475942293294 549 +0.5285920916905319 0.0594889040288523 550 +0.5085855457146059 0.06116777053765085 551 +0.2658085821260374 0.1222303929375429 552 +0.02707239850080475 0.03790394539366334 553 +1.369770132924487 0.8953989111910443 554 +0.4785701907739958 0.06269795728288877 555 +0.2866370469058047 0.06875320980650451 556 +1.101435700529601 0.5192124849885236 557 +0.6522888417918915 1.81298113208227 558 +0.7509085772393588 0.2467132726744609 559 +0.2164155749749514 0.06742024680914531 560 +0.2390447658021846 0.0669452029430742 561 +0.1017063663264694 0.1941615930069731 562 +0.5913127563455094 0.09573349983115355 563 +0.8635269173823855 0.04705913765227455 564 +0.04702784983427018 0.04605254825902746 565 +0.3283619022732957 0.06863397799672862 566 +0.3475764945534106 0.06925144187032933 567 +0.3786225333106139 0.0672242360731201 568 +0.1989979655697304 0.06674242969555405 569 +0.308375824740997 0.07041031506485744 570 +0.2556103412732861 0.07085159967224514 571 +4.918265493202966 0.9842288336482714 572 +3.140196698406169 2.892855328806442 573 +0.5526915360497741 0.1033206301882925 574 +0.2781449023837942 0.06856751060982008 575 +0.2845491439980584 0.4240685242536141 576 +0.510213367463374 0.0998917164694306 577 +-0.007289562763647924 0.01036613237501221 578 +-0.02854006431629975 0.08000761412764072 579 +0.6674622353468411 0.1768287882194176 580 +0.06745536687541184 0.0495791957765073 581 +0.7618892204059935 0.07507902464020741 582 +0.2078317384340663 0.06579022469391792 583 +0.09737473512849654 0.05580036408751288 584 +0.1575810944545936 0.06329950404445517 585 +0.1374789242896426 0.06177820520126404 586 +0.177305093922089 0.06600383486366548 587 +0.1178640119801193 0.05904129946203216 588 +3.208309663176561 3.908058311918774 589 +0.3920789876503485 0.1438191210588139 590 +2.784128015059756 0.5058226367739599 591 +0.3648301672893265 0.08868150137495001 592 +2.490610241339002 1.51967775950868 593 +0.9962524594638661 0.009166307355965792 594 +-2.475883290456877 0.6613568219126961 595 +0.6730107280586737 0.08347024919480733 596 +0.8919732486914205 0.05970241772017394 597 +0.0762272936429931 0.1053826527217888 598 +0.3849144142916567 0.2371031534452342 599 +0.3958255168401422 0.1128163077854117 600 +0.8988009860053211 0.1512164058197938 601 +-0.6552008302980705 3.929528290209231 602 +0.9625847000631123 0.04644196496594905 603 +-0.4792467458370923 0.7757237736082915 604 +0.7849307285798921 0.05724841441225931 605 +1.233638213612351 0.2385176976042464 606 +1.558492412578625 0.3817095861243631 607 +3.821092058762604 2.391218889524884 608 +-0.2602217067120544 0.5485265573564149 609 +0.5901252333599375 0.1619744058861268 610 +0.9199021386737649 0.3928926381846901 611 +-1.596449677551605 1.881126079160859 612 +0.09966849815593011 0.1396873733190519 613 +0.9145821075617704 0.03854810874304797 614 +0.7970377393028155 0.03403207482680545 615 +2.067843056153523 1.149760353799613 616 +0.4933090389745438 0.1641909068923078 617 +0.8331653570575477 0.04937028359342793 618 +-3.095399608180001 0.6078761194542023 619 +0.02676555597666492 0.218494312187591 620 +0.01376630016053545 0.3188537765593886 621 +-0.04005116004874151 0.1846813729755497 622 +-1.192204721544916 0.2292631034956435 623 +-1.518766710588333 0.3055617788564697 624 +0.9763832401913963 0.01139587029914633 625 +0.7966307807257201 0.1052835861896941 626 +1.311450255400667 0.07305982041386128 627 +1.040465954691319 0.1045749614334851 628 +0.8170581664000645 0.06044584951682775 629 +-0.05120699647189662 0.5540329644381496 630 +1.060261117779983 0.02056631513790547 631 +1.069661621024861 0.2046148369469178 632 +-0.6471167082330439 1.509044871321773 633 +0.2560656038113381 0.1601694732271217 634 +5.012313566449184 3.976235784417597 635 +0.4896680118333268 1.038903671627588 636 +0.8077387265786548 0.03360533542333399 637 +0.07562860165775427 0.0764164534740016 638 +0.7254036049939018 0.06865064539188824 639 +0.4684265307801967 0.4023567230485417 640 +0.5501488654305418 0.5134082054410537 641 +0.7657168767370183 2.759464947946896 642 +-0.01856135030934425 0.01038023687094224 643 +1.562456623703214 1.94298790444212 644 +1.165917465825424 0.7941796543768335 645 +1.084655975278898 0.1382442276478468 646 +0.6870650164339887 0.070701782379214 647 +0.3126957442644396 0.1131129563282292 648 +0.7594906718406219 0.1565360618547591 649 +0.788168363404969 0.03443206670647591 650 +-2.146408841516581 1.589447546046774 651 +0.8062657529975833 0.5611869036886294 652 +0.7742171096539084 0.7053821055223032 653 +0.9459835935939269 0.1319039022405838 654 +0.9840213688973191 0.1582855512860443 655 +0.6309547960114626 0.2855075838337904 656 +2.107977074231076 0.2501918885848057 657 +0.9355231801542945 0.2406738021089382 658 +0.8084112675785017 0.1456825388529177 659 +0.8735108853867318 0.2938035770932531 660 +-0.1619667854994181 0.2705512083230958 661 +0.1724098179128162 0.1229795279312078 662 +-0.4218724162260666 2.473283046189419 663 +-0.4310253281460014 0.09652183859669482 664 +0.4119025531599441 0.08056740353715891 665 +0.4160586756246168 0.0992151193318378 666 +4.099418701638036 0.5679404286146367 667 +0.9503494323587782 0.09158506635547532 668 +1.704911703271888 4.090115220084876 669 +0.4281209219258693 0.06470582375553995 670 +2.931738294631951 1.164790536869454 671 +0.4392796260928544 0.06449368160916907 672 +1.013319640845292 0.2713482515458746 673 +-1.150730068605009 1.448118870456547 674 +0.4484203345407515 0.06316035624981994 675 +0.7028617597674947 0.1112392016004072 676 +0.03793564734102105 0.1034932116741006 677 +0.05761404808449438 1.372435727567036 678 +-4.151634902239834 4.082500034474497 679 +1.846440244929411 0.1451089108698705 680 +0.3825232688684875 0.09736655207040754 681 +0.3503419146771583 0.105484634393207 682 +0.7178940712974481 0.05687753037671525 683 +0.6246634097379575 0.1636974136094161 684 +0.8671314422508236 0.02489463532623292 685 +0.5770844376136578 0.1102994832000407 686 +1.133306243466736 0.1085030462527676 687 +1.296654942883241 1.280271910693667 688 +0.6321463238203466 0.08533006198913773 689 +1.113827067986695 0.3895043214158217 690 +1.042666536164111 0.0417062722477721 691 +0.6984304096978811 0.05787201321813983 692 +1.397940317534175 0.4573962083571901 693 +0.05991810586521567 3.075147323450656 694 +-0.004857399215558878 0.05861594631031582 695 +0.4190806478881222 0.06373294396314992 696 +0.2468237275822783 0.06655420916016602 697 +0.4958472812611234 0.1132021133543415 698 +0.4441025468933009 0.08568932659733955 699 +-1.263085917659013 0.9324409551496007 700 +0.8208805961281049 0.2350507472680066 701 +-2.191356521058495 1.102145018342217 702 +-0.8626545747708418 0.6720439451547187 703 +0.2474174902745369 0.8261610887001976 704 +0.8813759821169523 0.09261140163530925 705 +1.133022467094247 -2.292574813171106 706 +1.061515127594296 -1.013283463355355 707 +-0.290441170763287 -1.203553437028785 708 +1.01907748177748 -0.3818937223863033 709 +-0.1055771851702392 -0.3875866013812702 710 +0.5001439907147722 -0.7052591449289658 711 +-0.05353041281907202 -0.1305202108925042 712 +0.1057296625475286 -0.2859009861591468 713 +1.00580987872332 -0.07443301076217992 714 +0.8842093280764689 -0.2058472838537492 715 +0.5996030501244187 -0.3777284793370799 716 +0.6847565638391742 -0.2230188834567269 717 +0.3553760535521138 -0.3169520985799389 718 +0.9116874263845535 -0.1054562453896149 719 +0.5181048369997199 -0.2182689975153164 720 +0.8284547476951123 -0.115384550398954 721 +0.7339522155281551 -0.1289253084236337 722 +0.6479641628607956 -0.1354177095609701 723 +1.584858066114726 -0.6456028768705619 724 +0.05908752479806186 -0.151063479393653 725 +-2.330770527655999 -2.37761762594278 726 +1.141741184107983 -0.1765917081786111 727 +0.5650137026511124 -0.1334788686142664 728 +0.4844542465803454 -0.1345787363157624 729 +0.3739490682819416 -0.1833101074605805 730 +0.2338691228028588 -0.1979005152606289 731 +3.110513646301363 -1.92850479039471 732 +-0.02526323725272406 -0.04283409263392056 733 +0.1438372120820715 -0.1458285033799114 734 +0.419286292623974 -0.1209772913451299 735 +0.9503466107124283 -0.06198023267694987 736 +0.01019599156172042 -0.08145121338091384 737 +0.2942832488974854 -0.1409089370923877 738 +-0.5498305322515241 -0.426588352472993 739 +0.233189102594193 -0.1187871164535187 740 +0.8738096527861967 -0.06957207644344354 741 +1.399462825774324 -0.2723248277776019 742 +0.7831234812272193 -0.07649975118315143 743 +0.3706899030375541 -0.1153976386162018 744 +1.000059447796042 -0.2064122675924326 745 +0.9110344063005742 -0.05533493866581874 746 +0.8316987751790581 -0.06815606459839867 747 +-0.2401232262617459 -0.1816215801987842 748 +0.7413919893191248 -0.07386745147563943 749 +0.692939580038738 -0.08879550379078179 750 +0.6512459667864866 -0.08196800438347067 751 +0.6129215408590118 -0.08730680657205386 752 +0.5712878196470932 -0.08563017050949565 753 +0.5295254218010549 -0.09069768843813372 754 +0.4893580109581563 -0.08968278868430965 755 +0.05859498158531985 -0.08361259998324404 756 +0.1174840916377135 -0.1020006364272524 757 +0.3301102561322488 -0.1007963006397734 758 +0.2871774378870555 -0.09955828589669091 759 +-0.7597713748955619 -3.106438759501699 760 +0.9801076052549856 -0.03853365922079686 761 +1.020054364356594 -0.04171659628472591 762 +1.087287806684492 -0.07909673227149255 763 +0.1942275773867594 -0.1009296323293485 764 +0.1546005664403405 -0.09540861208899813 765 +0.8130277750951015 -0.4054362995861286 766 +1.846723133268948 -1.575422420955336 767 +0.463128012717311 -0.08413447019443902 768 +0.4295229034640434 -0.08644391565818173 769 +0.3974269999416307 -0.08922199363261096 770 +-1.677242154556605 -1.264305661411473 771 +0.4288539533152302 -1.444973194982577 772 +0.8008008053544199 -0.0580077836113135 773 +0.2581158058716044 -0.09057780354730895 774 +0.2280374893441162 -0.08984802828896854 775 +2.461414419320008 -0.887690688253559 776 +0.1737994242269858 -0.5791547361548069 777 +0.7070640262346514 -0.06886954229509037 778 +-0.1605722765349137 -0.1100725679862969 779 +0.8801974610965735 -0.04279241712650217 780 +0.8488558259964192 -0.04280384607196223 781 +0.9290091252550543 -0.03540234602101866 782 +0.769114708824585 -0.05465015522407752 783 +1.064587492281639 -0.04618852538436446 784 +0.9981471485688321 -0.02453875358834575 785 +0.9595236061545296 -0.02855777428727144 786 +-0.405117218562989 -0.2155844328159443 787 +0.6691261561765083 -0.06375076367319582 788 +1.31688008795321 -0.1556588992958876 789 +0.9577693257147674 -0.7021166371575343 790 +0.5897554513240597 -0.07082936421761757 791 +0.6297636810194234 -0.06742942946072965 792 +0.5496287858570442 -0.07374904273748814 793 +1.301281934411415 -0.6104294412841623 794 +0.5122063505371426 -0.07706191304762504 795 +-1.21666347525173 -0.5209769228353688 796 +0.8162699442656614 -0.04397103251161766 797 +0.8984586733621764 -0.03568332549328285 798 +0.7492694642656328 -0.05275854111828147 799 +0.7302277486044122 -0.05349866988333438 800 +0.7891774994158786 -0.1880392913813375 801 +0.6872202371136191 -0.0563474087877472 802 +0.0973320569175883 -0.07575212245223317 803 +0.649274036348043 -0.06148872948675144 804 +2.37085450712631 -3.527309670195545 805 +0.3454333554934975 -0.08407314316035774 806 +0.04190198260936621 -0.0631081095175374 807 +0.311261885872677 -0.08582666938522475 808 +0.02001788942236895 -0.05101929089502889 809 +0.3817145776363622 -0.07920226524930571 810 +0.6046819642539226 -0.2099785409625784 811 +-0.05791826976868609 -0.03611800916655369 812 +0.9895344245291844 -0.1094208684627461 813 +0.3286455447337586 -0.080473431588664 814 +0.1359931135695697 -0.07697944405988857 815 +0.1729642261917955 -0.07899477518229266 816 +0.06615758133788094 -0.06266205669450618 817 +3.90764819122958 -1.405269808956741 818 +-2.85750257101334 -1.374952346596806 819 +0.2071816662834119 -0.07925910686932092 820 +0.1170425278758571 -0.07283124338350461 821 +-0.0006975758512239054 -0.03776751929577567 822 +4.090059454928133 -3.39183303399917 823 +0.4812251826219932 -0.0721663070347144 824 +0.438747453713259 -0.1885486365737779 825 +1.230905635669705 -0.3801522629683068 826 +0.6097019835253347 -0.06526777400412775 827 +0.5694412470463093 -0.06767010131395179 828 +-0.8889793259075329 -1.981082583892683 829 +1.846440244929411 -0.3460888454484239 830 +0.5295747949969293 -0.07103930787319526 831 +0.2796486570886359 -0.07905306639140723 832 +0.5857582181319352 -3.819323261249364 833 +0.97793248517497 -0.02190231377300575 834 +3.380471891546353 -0.5944742540599415 835 +-0.8206605333709425 -1.089445630867074 836 +0.8732680779310409 -0.1188010840888673 837 +0.7911206236011585 -0.04363243542909703 838 +1.213857600596963 -0.09591201103589027 839 +1.028240155663608 -0.1542857646538186 840 +0.7635684734857492 -0.9103737120965906 841 +-0.06249791453293805 -0.2633518239349565 842 +0.77983547349166 -0.1283789492462569 843 +0.8693057559420008 -0.03396200030987235 844 +-0.01509644690734814 -0.02298424485346713 845 +0.9388593698630221 -0.1788434926531503 846 +0.4478756947095481 -0.07231303229891443 847 +0.3336030075613414 -2.360162078810138 848 +0.6612707552243378 -0.5855987754500577 849 +-0.03213602694497882 -0.01855080693783812 850 +1.138988651260337 -0.05267055237662466 851 +0.1565401618816491 -0.07451784335346845 852 +0.222041422670613 -0.2985116684491496 853 +0.4205565602273984 -0.07251533875887456 854 +0.4019812833802173 -0.5198358763149915 855 +0.8380825718400099 -0.03536059453890464 856 +0.9364769616020944 -0.0211905077265465 857 +0.9176164084978377 -0.02553512292275099 858 +0.6912620644578676 -0.1404906660349693 859 +1.037697925137481 -0.0221141345243346 860 +0.1353176562597431 -1.069145151453879 861 +-3.790632074197686 -2.519243281305949 862 +0.4478393234558604 -0.2848793666044512 863 +0.2429809311635154 -0.07640958678991916 864 +-0.08049320915707396 -0.8034558069662339 865 +0.3086601588839856 -0.2118255524985024 866 +1.650244876257552 -1.075160812768154 867 +1.236424336868036 -1.711100866434157 868 +0.9517066600067464 -0.3177360671024411 869 +0.8102803034517809 -0.08185224425713662 870 +1.606410251883439 -0.1887541463486254 871 +0.7902710299231159 -0.3010281273627875 872 +2.109252989008789 -2.384861533402403 873 +0.3406458832823571 -0.1384745871562269 874 +0.08542877397246135 -0.06067835658552759 875 +1.10388945557836 -0.2767588205227071 876 +-1.76301580627408 -3.575794498985556 877 +0.4988968652664467 -0.06662678452423131 878 +0.7086271479461395 -0.04938338115713597 879 +-0.8464402449305194 -0.2870880376603548 880 +0.8026524136171362 -0.04232325538836208 881 +0.6055145230297979 -0.1246016764811833 882 +0.5236090358558134 -0.1260685299438306 883 +0.7677364802661317 -0.03798538973956274 884 +0.7232851137540355 -0.09154632210175917 885 +1.01914235746581 -0.01746422048633432 886 +0.357624090142198 -0.07193751971928126 887 +-1.79974575722611 -0.6206627288168891 888 +0.8875531905884624 -0.02732551380183655 889 +0.9315236694898013 -0.5064497278710688 890 +-0.3113974071378099 -0.09683997464117444 891 +0.2958537036185662 -0.07469544933049709 892 +0.398717094507435 -0.07238457970965895 893 +1.040387502424061 -0.06572374014360682 894 +0.6782064841926765 -0.04925639301027087 895 +0.7258232549370182 -0.1813078199057664 896 +0.4696099332552007 -0.06540661998511804 897 +0.1894864048468744 -0.07207141604459258 898 +0.6386127124518282 -0.05375767416689015 899 +0.6585605878261384 -0.05193608161180636 900 +0.7382603655826248 -0.04321616929941074 901 +0.01629934328556063 -0.03548979005017698 902 +0.4349326541748024 -0.07435074628109274 903 +0.7070937717247926 -0.3254126754136118 904 +0.1969739113744336 -0.1497513621305455 905 +2.346964043460392 -0.4705428772435565 906 +1.005668237694938 -0.01223361421250536 907 +0.8483172687968208 -0.08994800171108097 908 +1.415420788797758 -0.1137281915065426 909 +0.8446223242404119 -0.1655506050739253 910 +0.5986846859539089 -0.0570794646794281 911 +0.6186462688755362 -0.05538357301893775 912 +1.094802226006767 -0.03181971502579847 913 +0.5587390249625277 -0.06026795463863399 914 +0.5787157663483566 -0.05870956677962409 915 +0.2277038628489899 -0.07330214585144916 916 +0.5187617400521517 -0.06316493970635337 917 +0.5387547947986809 -0.06175920050953287 918 +0.0362599567280008 -0.04521975146079152 919 +-0.2870383598223001 -0.341037768415444 920 +-0.07155142358353155 -1.759009599353974 921 +0.9866579422636139 -0.01283972712362145 922 +0.9668259037102853 -0.01527748173956463 923 +-0.2136404170979795 -0.06311849004701374 924 +2.001447081272526 -0.6893951194385386 925 +0.08567013935606274 -0.4276000393188706 926 +0.2680502014314983 -0.07208065277550028 927 +-0.1145972354350398 -0.1791582576301666 928 +0.05652320108856926 -0.05080961528308429 929 +0.3183227532343028 -0.07177674908063197 930 +0.3384125136538808 -0.07151681898081239 931 +0.6702578639111858 -0.1068647705246969 932 +-0.574386847201706 -0.1701847860778404 933 +0.9781352425034654 -0.06610321810122315 934 +-0.09857779329782743 -0.03164309087910859 935 +-0.1440890574420423 -0.04577401585544571 936 +-0.09366041926107002 -0.08748436806259496 937 +0.8577583193683916 -0.02943332827282375 938 +0.7600804808023139 -0.09728734438444434 939 +4.857042314529068 -2.337631467123563 940 +-3.019311008229438 -3.713396367183682 941 +0.003604208740306453 -0.1318822543074988 942 +0.4423877779348111 -0.1052638035384789 943 +0.4479705484884566 -0.1444079834662227 944 +0.1472329481772825 -0.06529909873601476 945 +0.1077971627542764 -0.05994682968799508 946 +0.1673770944232773 -0.06716725110035456 947 +0.1680491714649187 -0.2124357492384706 948 +0.1270812852417307 -0.06309553994883037 949 +0.8263417285923504 -0.03428183709016133 950 +0.9480810047561704 -0.01944718051848266 951 +0.9269042836427757 -0.02048392852718193 952 +0.9062437582573348 -0.02479290956948605 953 +0.8533807107284858 -1.310066290614428 954 +0.9264092950498557 -0.07464593355600052 955 +0.8997974812707807 -0.07927960316567267 956 +0.0082078227411115 -0.02664176927605435 957 +-0.001090103618027358 -0.0204278785232963 958 +0.6346540982178304 -0.1046160092561691 959 +0.9448104345599719 -0.03703494178043447 960 +0.4705602823956213 -0.1102976957981052 961 +0.6982254682534346 -0.04597914080984904 962 +0.7181478222469381 -0.04398541427453472 963 +0.7579852185854171 -0.04092913003162207 964 +0.7791736952411442 -0.04068586292316081 965 +-3.898839516877382 -1.003071436149013 966 +0.5586386180030942 -0.2913993470343105 967 +0.8763950088076913 -0.02652560872033836 968 +0.4869512615238851 -0.06164890751965951 969 +0.9964508478814396 -0.04906504759145432 970 +0.5469680957744969 -0.1732725582459685 971 +-1.293216529705824 -2.557392034715658 972 +1.425088660766374 -3.103943219918337 973 +0.847384891703524 -0.02876938436568131 974 +0.9567756031137487 -0.01495245599275727 975 +0.8968357180478533 -0.02314658308342501 976 +0.8172227999420139 -0.03195964651907573 977 +0.3874706410987171 -0.06737876067175445 978 +0.4104272719791168 -0.06728171709252967 979 +0.6869714570694635 -0.4577477337935655 980 +0.07627730783405631 -0.0526205842974494 981 +0.8512344844140824 -0.06379115923989739 982 +0.747902091782769 -0.03986486637280265 983 +0.6482921698921303 -0.04984403522155641 984 +0.6681450395809249 -0.04865697178023839 985 +0.9299499562295149 -0.05226768035605534 986 +0.7281714306665661 -0.04145320280880533 987 +0.6084752783796064 -0.05335864249710827 988 +0.628389661660382 -0.05185042112685747 989 +0.5885295295306866 -0.05579981943711653 990 +0.687658321001992 -0.0452223427013014 991 +0.3698367825319763 -0.0708188110286285 992 +0.5685126436176755 -0.05663415755692768 993 +0.4575496661417661 -0.06589583778557079 994 +0.5485754476521957 -0.05887475966875534 995 +0.5285920890164743 -0.05948890426492487 996 +0.5085855429243116 -0.06116777077383374 997 +0.2658085805238671 -0.1222303925727865 998 +0.02707239829286616 -0.03790394524289226 999 +1.369770136954519 -0.895398917950387 1000 +0.4785701880507325 -0.06269795740338893 1001 +0.2866370452379062 -0.06875320974866039 1002 +1.101435701131939 -0.5192124886929347 1003 +0.6522888419973014 -1.812981140561063 1004 +0.7509085758193451 -0.2467132740393886 1005 +0.2164155736896141 -0.0674202467007666 1006 +0.2390447643948098 -0.06694520285637218 1007 +0.1017063654577343 -0.1941615922593616 1008 +0.5913127540106686 -0.09573350030809535 1009 +0.8635269166006108 -0.04705913791075024 1010 +0.0470278495046134 -0.04605254809996689 1011 +0.3283619003740692 -0.06863397797192905 1012 +0.3475764925470141 -0.06925144185721273 1013 +0.378622531136787 -0.06722423609449132 1014 +0.1989979643814462 -0.06674242957539184 1015 +0.3083758229515475 -0.07041031501470366 1016 +0.2556103397721922 -0.07085159957797578 1017 +4.918265493635758 -0.9842288318198454 1018 +3.140196707677128 -2.892855328810752 1019 +0.5526915335009164 -0.1033206306672235 1020 +0.2781449007619284 -0.06856751054744678 1021 +0.2845491415361862 -0.4240685236185366 1022 +0.5102133647139574 -0.09989171680957805 1023 +-0.007289562774886908 -0.010366132324293 1024 +-0.02854006419533988 -0.08000761344171187 1025 +0.6674622334071841 -0.1768287892067822 1026 +0.06745536643002684 -0.04957919562129336 1027 +0.7618892190574409 -0.07507902503988957 1028 +0.2078317371972785 -0.06579022458702476 1029 +0.09737473451304383 -0.05580036393043247 1030 +0.1575810934967777 -0.06329950390555018 1031 +0.1374789234449513 -0.06177820505144382 1032 +0.1773050928537644 -0.06600383472828192 1033 +0.1178640112471433 -0.05904129930808519 1034 +3.208309679385692 -3.908058316528267 1035 +0.3920789853175387 -0.1438191205490287 1036 +2.784128014023627 -0.5058226365525889 1037 +0.3648301651761022 -0.0886815012704705 1038 +2.490610250850437 -1.519677752233717 1039 +0.9962524594216139 -0.009166307393316826 1040 +-2.475883299176789 -0.6613568315616034 1041 +0.6730107261904402 -0.08347024962801441 1042 +0.8919732480624667 -0.05970241806571195 1043 +0.07622729308057877 -0.1053826522757108 1044 +0.3849144115774321 -0.2371031523434502 1045 +0.3958255145511561 -0.1128163075828273 1046 +0.8988009854313154 -0.1512164067260668 1047 +-0.6552008268537124 -3.929528288257774 1048 +0.9625846998370762 -0.04644196521333515 1049 +-0.4792467450582403 -0.7757237715959915 1050 +0.7849307273666795 -0.05724841471366267 1051 +1.233638213414829 -0.2385176972664169 1052 +1.558492412766872 -0.3817095864776667 1053 +3.821092062933054 -2.391218885856988 1054 +-0.2602217058534311 -0.5485265536723734 1055 +0.590125230981798 -0.1619744066983462 1056 +0.9199021381071667 -0.3928926406185673 1057 +-1.596449678844752 -1.881126082960473 1058 +0.09966849741123196 -0.1396873727471778 1059 +0.9145821070678903 -0.03854810896321228 1060 +0.7970377381613254 -0.03403207500011503 1061 +2.067843064640399 -1.149760355557845 1062 +0.4933090362353485 -0.1641909070101464 1063 +0.8331653561088088 -0.04937028385841143 1064 +-3.095399610835932 -0.6078761228614843 1065 +0.02676555549125479 -0.2184943110712597 1066 +0.01376629966178395 -0.3188537752596901 1067 +-0.04005115971109773 -0.1846813715672772 1068 +-1.192204721891575 -0.229263103961226 1069 +-1.518766711381206 -0.3055617796227993 1070 +0.9763832400310662 -0.01139587036063998 1071 +0.7966307795696197 -0.1052835867642871 1072 +1.311450255382808 -0.07305982036766409 1073 +1.04046595477196 -0.1045749617479393 1074 +0.8170581653633966 -0.06044584983776 1075 +-0.05120699653960922 -0.5540329564415221 1076 +1.060261117773125 -0.02056631514836526 1077 +1.069661621727034 -0.204614838090843 1078 +-0.6471167104545603 -1.509044869201736 1079 +0.2560656022141504 -0.160169472656036 1080 +5.012313571181569 -3.976235788884982 1081 +0.4896680096774081 -1.038903673725206 1082 +0.8077387254941744 -0.03360533559624285 1083 +0.07562860113852089 -0.07641645318322036 1084 +0.7254036034304552 -0.06865064576167626 1085 +0.4684265260311241 -0.4023567228934626 1086 +0.5501488594695336 -0.5134082093298903 1087 +0.7657168754693386 -2.759464968588059 1088 +-0.01856135031179823 -0.01038023682311965 1089 +1.56245663552119 -1.942987921445798 1090 +1.165917466807299 -0.794179661270188 1091 +1.084655975572534 -0.1382442280438867 1092 +0.6870650146472997 -0.07070178274706924 1093 +0.3126957424143648 -0.1131129560340607 1094 +0.7594906704646919 -0.1565360627286503 1095 +0.788168362214924 -0.03443206688096102 1096 +-2.146408843634843 -1.589447553612822 1097 +0.8062657513123953 -0.5611869068849616 1098 +0.7742171078531375 -0.7053821091455552 1099 +0.9459835933231919 -0.1319039030081611 1100 +0.9840213689208714 -0.1582855522121352 1101 +0.6309547935890805 -0.2855075852408615 1102 +2.107977073068932 -0.2501918878577086 1103 +0.935523179836939 -0.2406738036293893 1104 +0.8084112664804808 -0.1456825396703826 1105 +0.8735108846172976 -0.2938035789207745 1106 +-0.1619667842444526 -0.2705512063121243 1107 +0.1724098168209012 -0.1229795274822009 1108 +-0.4218724169544675 -2.473283044347362 1109 +-0.4310253280592562 -0.09652183870699182 1110 +0.411902550790466 -0.08056740351208258 1111 +0.4160586732176802 -0.09921511921155191 1112 +4.099418701520254 -0.5679404273115334 1113 +0.9503494320837798 -0.09158506686578261 1114 +1.704911705770006 -4.09011523027265 1115 +0.4281209194784004 -0.06470582382672449 1116 +2.931738287086433 -1.164790520891041 1117 +0.4392796235832906 -0.06449368169654238 1118 +1.013319641120433 -0.2713482532206861 1119 +-1.1507300709287 -1.448118871152415 1120 +0.4484203319823047 -0.06316035635839187 1121 +0.7028617580667269 -0.1112392022114057 1122 +0.03793564699169091 -0.1034932111736855 1123 +0.05761404567517718 -1.372435726142426 1124 +-4.151634890388542 -4.082500024568467 1125 +1.846440244929411 -0.1451089103246328 1126 +0.3825232666488997 -0.09736655193153723 1127 +0.350341912624352 -0.1054846341686061 1128 +0.7178940696925192 -0.05687753067435434 1129 +0.6246634075618313 -0.1636974144693327 1130 +0.8671314414913296 -0.02489463546065937 1131 +0.5770844351933802 -0.1102994837601264 1132 +1.133306243644462 -0.108503046381301 1133 +1.296654947971482 -1.280271918342022 1134 +0.632146321720688 -0.0853300624181058 1135 +1.113827068539371 -0.3895043236425629 1136 +1.042666536221476 -0.04170627236588979 1137 +0.6984304079781003 -0.0578720135153435 1138 +1.397940317857424 -0.4573962096092201 1139 +0.05991810174588958 -3.075147320515317 1140 +-0.004857399263039696 -0.05861594592947016 1141 +0.4190806454916743 -0.06373294403245718 1142 +0.2468237261323944 -0.06655420908211657 1143 +0.4958472784770191 -0.1132021136313669 1144 +0.4441025443389763 -0.0856893265925561 1145 +-1.263085920144253 -0.9324409565846503 1146 +0.8208805950705408 -0.2350507486607004 1147 +-2.191356525121538 -1.102145024399919 1148 +-0.862654575167868 -0.672043945336072 1149 +0.2474174884061102 -0.8261610871112404 1150 +0.8813759814338784 -0.09261140215973589 1151 +NMARK= 3 +MARKER_TAG= farfield +MARKER_ELEMS= 26 +3 2 210 +3 210 211 +3 211 3 +3 3 212 +3 212 213 +3 213 214 +3 214 215 +3 215 216 +3 216 217 +3 217 4 +3 4 218 +3 218 219 +3 219 5 +3 5 220 +3 220 221 +3 221 6 +3 6 222 +3 222 223 +3 223 224 +3 224 225 +3 225 226 +3 226 227 +3 227 7 +3 7 228 +3 228 229 +3 229 2 +MARKER_TAG= airfoil +MARKER_ELEMS= 102 +3 1 8 +3 8 9 +3 9 10 +3 10 11 +3 11 12 +3 12 13 +3 13 14 +3 14 15 +3 15 16 +3 16 17 +3 17 18 +3 18 19 +3 19 20 +3 20 21 +3 21 22 +3 22 23 +3 23 24 +3 24 25 +3 25 26 +3 26 27 +3 27 28 +3 28 29 +3 29 30 +3 30 31 +3 31 32 +3 32 33 +3 33 34 +3 34 35 +3 35 36 +3 36 37 +3 37 38 +3 38 39 +3 39 40 +3 40 41 +3 41 42 +3 42 43 +3 43 44 +3 44 45 +3 45 46 +3 46 47 +3 47 48 +3 48 49 +3 49 50 +3 50 51 +3 51 52 +3 52 53 +3 53 54 +3 54 55 +3 55 56 +3 56 57 +3 57 58 +3 58 59 +3 59 60 +3 60 61 +3 61 62 +3 62 63 +3 63 64 +3 64 65 +3 65 66 +3 66 67 +3 67 68 +3 68 69 +3 69 70 +3 70 71 +3 71 72 +3 72 73 +3 73 74 +3 74 75 +3 75 76 +3 76 77 +3 77 78 +3 78 79 +3 79 80 +3 80 81 +3 81 82 +3 82 83 +3 83 84 +3 84 85 +3 85 86 +3 86 87 +3 87 88 +3 88 89 +3 89 90 +3 90 91 +3 91 92 +3 92 93 +3 93 94 +3 94 95 +3 95 96 +3 96 97 +3 97 98 +3 98 99 +3 99 100 +3 100 101 +3 101 102 +3 102 103 +3 103 104 +3 104 105 +3 105 106 +3 106 107 +3 107 108 +3 108 0 +MARKER_TAG= airfoil_ +MARKER_ELEMS= 102 +3 0 109 +3 109 110 +3 110 111 +3 111 112 +3 112 113 +3 113 114 +3 114 115 +3 115 116 +3 116 117 +3 117 118 +3 118 119 +3 119 120 +3 120 121 +3 121 122 +3 122 123 +3 123 124 +3 124 125 +3 125 126 +3 126 127 +3 127 128 +3 128 129 +3 129 130 +3 130 131 +3 131 132 +3 132 133 +3 133 134 +3 134 135 +3 135 136 +3 136 137 +3 137 138 +3 138 139 +3 139 140 +3 140 141 +3 141 142 +3 142 143 +3 143 144 +3 144 145 +3 145 146 +3 146 147 +3 147 148 +3 148 149 +3 149 150 +3 150 151 +3 151 152 +3 152 153 +3 153 154 +3 154 155 +3 155 156 +3 156 157 +3 157 158 +3 158 159 +3 159 160 +3 160 161 +3 161 162 +3 162 163 +3 163 164 +3 164 165 +3 165 166 +3 166 167 +3 167 168 +3 168 169 +3 169 170 +3 170 171 +3 171 172 +3 172 173 +3 173 174 +3 174 175 +3 175 176 +3 176 177 +3 177 178 +3 178 179 +3 179 180 +3 180 181 +3 181 182 +3 182 183 +3 183 184 +3 184 185 +3 185 186 +3 186 187 +3 187 188 +3 188 189 +3 189 190 +3 190 191 +3 191 192 +3 192 193 +3 193 194 +3 194 195 +3 195 196 +3 196 197 +3 197 198 +3 198 199 +3 199 200 +3 200 201 +3 201 202 +3 202 203 +3 203 204 +3 204 205 +3 205 206 +3 206 207 +3 207 208 +3 208 209 +3 209 1 diff --git a/blast/tests/su2/blisu2.py b/blast/tests/su2/blisu2.py new file mode 100644 index 0000000000000000000000000000000000000000..f8383801b5773cdbab23603388933ac40b6bdecc --- /dev/null +++ b/blast/tests/su2/blisu2.py @@ -0,0 +1,82 @@ +#!/usr/bin/env python3 +# -*- coding: utf-8 -*- + +# Copyright 2022 University of Liège +# +# Licensed under the Apache License, Version 2.0 (the "License"); +# you may not use this file except in compliance with the License. +# You may obtain a copy of the License at +# +# http://www.apache.org/licenses/LICENSE-2.0 +# +# Unless required by applicable law or agreed to in writing, software +# distributed under the License is distributed on an "AS IS" BASIS, +# WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. +# See the License for the specific language governing permissions and +# limitations under the License. + + +# @author Paul Dechamps +# @date 2022 +# Test the vii implementation using SU2 as the inviscid solver + +# Imports. +from blast.blCoupler import Coupler +import blast.blUtils as vutils + +def cfgSu2(): + return { + 'filename' : '/home/c130/lab/blaster/blast/tests/su2/config.cfg', + 'wingTags' : ['airfoil', 'airfoil_'], + } + +def cfgBlast(): + return { + 'Re' : 1e7, # Freestream Reynolds number + 'CFL0' : 1, # Inital CFL number of the calculation + 'couplIter': 50, # Maximum number of iterations + 'sections': {'airfoil': [0.0]}, + 'spans': {'airfoil': 1.0}, + 'couplTol' : 1e-4, # Tolerance of the VII methodology + 'iterPrint': 1, # int, number of iterations between outputs + 'resetInv' : True, # bool, flag to reset the inviscid calculation at every iteration. + 'xtrF' : [None, 0.4], # Forced transition locations + 'interpolator' : 'Matching',# Interpolator for the coupling + } + +def main(): + + icfg = cfgSu2() + vcfg = cfgBlast() + coupler, isol, vsol = vutils.initBlast(icfg, vcfg, iSolver='SU2', task='analysis') + coupler.run() + print('ok main') + quit() + + # Extract solution + + # Display results + from matplotlib import pyplot as plt + fig, (ax1, ax2) = plt.subplots(1, 2) + ax1.plot(cpCorrected[:,0], cpCorrected[:,1], lw=3) + ax1.plot(su2API.cp0[:,0], su2API.cp0[:,1], '--', lw=1.5, color='black') + ax1.invert_yaxis() + ax1.set_ylabel('$c_p$') + ax2.plot(solsu2['xoc'], solsu2['Cf'], lw=3) + ax2.set_ylabel('$c_f$') + ax2.set_xlim([0,1]) + plt.show() + + plt.plot(cpCorrected[:,0], cpCorrected[:,1], lw=3, color='darkblue') + plt.plot(su2API.cp0[:,0], su2API.cp0[:,1], '--', lw=3, color='black') + plt.xticks([0, 1]) + plt.yticks([-1, 0, 1]) + plt.gca().invert_yaxis() + + for i, spine in enumerate(plt.gca().spines.values()): + if i%2 != 0: + spine.set_visible(False) + plt.show() + +if __name__ == "__main__": + main() diff --git a/blast/tests/su2/config.cfg b/blast/tests/su2/config.cfg new file mode 100644 index 0000000000000000000000000000000000000000..75ed473754e4f810d29680617a226d9fe415e5e4 --- /dev/null +++ b/blast/tests/su2/config.cfg @@ -0,0 +1,220 @@ +%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% +% % +% SU2 configuration file % +% Case description: Inviscid, internal flow over a bump in a channel % +% Author: Thomas D. Economon % +% Institution: Stanford University % +% Date: 2012.09.29 % +% File Version 4.0.2 "Cardinal" % +% % +%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% + +% ------------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION ------------% +% +% Physical governing equations (EULER, NAVIER_STOKES, NS_PLASMA) +% +SOLVER= EULER +% +% Mathematical problem (DIRECT, CONTINUOUS_ADJOINT) +MATH_PROBLEM= DIRECT +% +% Restart solution (NO, YES) +RESTART_SOL= NO + +% -------------------- COMPRESSIBLE FREE-STREAM DEFINITION --------------------% +% +% Mach number (non-dimensional, based on the free-stream values) +MACH_NUMBER= 0.20 +% +% Angle of attack (degrees, only for compressible flows) +AOA= 2.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 + +REF_DIMENSIONALIZATION= FREESTREAM_VEL_EQ_ONE + +% ---------------------- REFERENCE VALUE DEFINITION ---------------------------% +% +% Reference origin for moment computation +REF_ORIGIN_MOMENT_X = 0.25 +REF_ORIGIN_MOMENT_Y = 0.00 +REF_ORIGIN_MOMENT_Z = 0.00 +% +% Reference length for pitching, rolling, and yawing non-dimensional moment +REF_LENGTH= 1.0 +% +% Reference area for force coefficients (0 implies automatic calculation) +REF_AREA= 1.0 + +% -------------------- BOUNDARY CONDITION DEFINITION --------------------------% +% +% Euler wall boundary marker(s) (NONE = no marker) +MARKER_EULER= ( airfoil, airfoil_ ) +% +SURFACE_MOVEMENT= (MOVING_WALL, MOVING_WALL) +% +MARKER_MOVING= ( airfoil, airfoil_ ) +% Motion mach number (non-dimensional). Used for initializing a viscous flow +% with the Reynolds number and for computing force coeffs. with dynamic meshes. +%MACH_MOTION= 0. +% 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. +% Default: Mach ~ 0.1 +MARKER_FAR = (farfield) + +% ------------------------ SURFACES IDENTIFICATION ----------------------------% +% +% Marker(s) of the surface to be plotted or designed + +MARKER_PLOTTING= ( airfoil, airfoil_ ) +% +% Marker(s) of the surface where the functional (Cd, Cl, etc.) will be evaluated +MARKER_MONITORING= ( airfoil, airfoil_ ) + +% ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------% +% +% Numerical method for spatial gradients (GREEN_GAUSS, WEIGHTED_LEAST_SQUARES) +NUM_METHOD_GRAD= WEIGHTED_LEAST_SQUARES + +SLOPE_LIMITER_FLOW= VENKATAKRISHNAN_WANG +VENKAT_LIMITER_COEFF= 0.1 +% +% Courant-Friedrichs-Lewy condition of the finest grid +CFL_NUMBER= 1e3 +% +% 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= ( 0.1, 5.0, 50.0, 1e10 ) +% +% Runge-Kutta alpha coefficients +%RK_ALPHA_COEFF= ( 0.66667, 0.66667, 1.000000 ) +% +% Number of total iterations +ITER= 999999 + +% ------------------------ LINEAR SOLVER DEFINITION ---------------------------% +% +% Linear solver for implicit formulations (BCGSTAB, FGMRES) +LINEAR_SOLVER= FGMRES +% +% Preconditioner of the Krylov linear solver (ILU, JACOBI, LINELET, LU_SGS) +LINEAR_SOLVER_PREC= ILU +% +% Minimum error of the linear solver for implicit formulations +LINEAR_SOLVER_ERROR= 1E-6 +% +% Max number of iterations of the linear solver for the implicit formulation +LINEAR_SOLVER_ITER= 10 + +% -------------------------- MULTIGRID PARAMETERS -----------------------------% +% +% Multi-Grid Levels (0 = no multi-grid) +MGLEVEL= 0 +% +% Multi-grid cycle (V_CYCLE, W_CYCLE, FULLMG_CYCLE) +MGCYCLE= W_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= 1.0 +% +% Damping factor for the correction prolongation +MG_DAMP_PROLONGATION= 1.0 + +% -------------------- FLOW NUMERICAL METHOD DEFINITION -----------------------% +% +% Convective numerical method (JST, LAX-FRIEDRICH, CUSP, ROE, AUSM, HLLC, +% TURKEL_PREC, MSW) +CONV_NUM_METHOD_FLOW= ROE +% +% 2nd and 4th order artificial dissipation coefficients +%JST_SENSOR_COEFF= ( 0.01, 0.01 ) +% +% Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT, EULER_EXPLICIT) +TIME_DISCRE_FLOW= EULER_IMPLICIT + +% --------------------------- CONVERGENCE PARAMETERS --------------------------% +% +% Convergence criteria (CAUCHY, RESIDUAL) +CONV_FIELD= RMS_DENSITY +% +% Min value of the residual (log10 of the residual) +CONV_RESIDUAL_MINVAL= -8 +% +% Start convergence criteria at iteration number +CONV_STARTITER= 10 +% +% Number of elements to apply the criteria +CONV_CAUCHY_ELEMS= 100 +% +% Epsilon to control the series convergence +CONV_CAUCHY_EPS= 1E-10 + +% ------------------------- INPUT/OUTPUT INFORMATION --------------------------% +% +SCREEN_WRT_FREQ_INNER= 5 +VOLUME_OUTPUT = SOLUTION, PRIMITIVE, RMS_DENSITY + +% Mesh input file +MESH_FILENAME= /home/c130/lab/blaster/blast/models/su2/n0012_su2.su2 +% +% Mesh input file format (SU2, CGNS, NETCDF_ASCII) +MESH_FORMAT= SU2 +% +% Mesh output file +MESH_OUT_FILENAME= mesh_out.su2 +% +% Restart flow input file +SOLUTION_FILENAME= solution_flow.dat +% +% Restart adjoint input file +SOLUTION_ADJ_FILENAME= solution_adj.dat +% +% Output file format (PARAVIEW, TECPLOT, STL) +TABULAR_FORMAT= CSV +% +% Output file convergence history (w/o extension) +CONV_FILENAME= history +% +% Output file restart flow +RESTART_FILENAME= restart_flow.dat +% +% Output file restart adjoint +RESTART_ADJ_FILENAME= restart_adj.dat +% +% Output file flow (w/o extension) variables +VOLUME_FILENAME= flow +% +% Output file adjoint (w/o extension) variables +VOLUME_ADJ_FILENAME= adjoint +% +% Output objective function gradient (using continuous adjoint) +GRAD_OBJFUNC_FILENAME= of_grad.dat +% +% Output file surface flow coefficient (w/o extension) +SURFACE_FILENAME= surface_flow +% +% Output file surface adjoint coefficient (w/o extension) +SURFACE_ADJ_FILENAME= surface_adjoint +% +%